DOE Office of Scientific and Technical Information (OSTI.GOV)
Kim, Kyungjoo; Parks, Michael L.; Perego, Mauro
2016-11-09
ISPH code is developed to solve multi-physics meso-scale flow problems using implicit SPH method. In particular, the code can provides solutions for incompressible, multi phase flow and electro-kinetic flows.
GASOLINE: Smoothed Particle Hydrodynamics (SPH) code
NASA Astrophysics Data System (ADS)
N-Body Shop
2017-10-01
Gasoline solves the equations of gravity and hydrodynamics in astrophysical problems, including simulations of planets, stars, and galaxies. It uses an SPH method that features correct mixing behavior in multiphase fluids and minimal artificial viscosity. This method is identical to the SPH method used in the ChaNGa code (ascl:1105.005), allowing users to extend results to problems requiring >100,000 cores. Gasoline uses a fast, memory-efficient O(N log N) KD-Tree to solve Poisson's Equation for gravity and avoids artificial viscosity in non-shocking compressive flows.
ZENO: N-body and SPH Simulation Codes
NASA Astrophysics Data System (ADS)
Barnes, Joshua E.
2011-02-01
The ZENO software package integrates N-body and SPH simulation codes with a large array of programs to generate initial conditions and analyze numerical simulations. Written in C, the ZENO system is portable between Mac, Linux, and Unix platforms. It is in active use at the Institute for Astronomy (IfA), at NRAO, and possibly elsewhere. Zeno programs can perform a wide range of simulation and analysis tasks. While many of these programs were first created for specific projects, they embody algorithms of general applicability and embrace a modular design strategy, so existing code is easily applied to new tasks. Major elements of the system include: Structured data file utilities facilitate basic operations on binary data, including import/export of ZENO data to other systems.Snapshot generation routines create particle distributions with various properties. Systems with user-specified density profiles can be realized in collisionless or gaseous form; multiple spherical and disk components may be set up in mutual equilibrium.Snapshot manipulation routines permit the user to sift, sort, and combine particle arrays, translate and rotate particle configurations, and assign new values to data fields associated with each particle.Simulation codes include both pure N-body and combined N-body/SPH programs: Pure N-body codes are available in both uniprocessor and parallel versions.SPH codes offer a wide range of options for gas physics, including isothermal, adiabatic, and radiating models. Snapshot analysis programs calculate temporal averages, evaluate particle statistics, measure shapes and density profiles, compute kinematic properties, and identify and track objects in particle distributions.Visualization programs generate interactive displays and produce still images and videos of particle distributions; the user may specify arbitrary color schemes and viewing transformations.
Multiphysics Code Demonstrated for Propulsion Applications
NASA Technical Reports Server (NTRS)
Lawrence, Charles; Melis, Matthew E.
1998-01-01
The utility of multidisciplinary analysis tools for aeropropulsion applications is being investigated at the NASA Lewis Research Center. The goal of this project is to apply Spectrum, a multiphysics code developed by Centric Engineering Systems, Inc., to simulate multidisciplinary effects in turbomachinery components. Many engineering problems today involve detailed computer analyses to predict the thermal, aerodynamic, and structural response of a mechanical system as it undergoes service loading. Analysis of aerospace structures generally requires attention in all three disciplinary areas to adequately predict component service behavior, and in many cases, the results from one discipline substantially affect the outcome of the other two. There are numerous computer codes currently available in the engineering community to perform such analyses in each of these disciplines. Many of these codes are developed and used in-house by a given organization, and many are commercially available. However, few, if any, of these codes are designed specifically for multidisciplinary analyses. The Spectrum code has been developed for performing fully coupled fluid, thermal, and structural analyses on a mechanical system with a single simulation that accounts for all simultaneous interactions, thus eliminating the requirement for running a large number of sequential, separate, disciplinary analyses. The Spectrum code has a true multiphysics analysis capability, which improves analysis efficiency as well as accuracy. Centric Engineering, Inc., working with a team of Lewis and AlliedSignal Engines engineers, has been evaluating Spectrum for a variety of propulsion applications including disk quenching, drum cavity flow, aeromechanical simulations, and a centrifugal compressor flow simulation.
Unsteady Cascade Aerodynamic Response Using a Multiphysics Simulation Code
NASA Technical Reports Server (NTRS)
Lawrence, C.; Reddy, T. S. R.; Spyropoulos, E.
2000-01-01
The multiphysics code Spectrum(TM) is applied to calculate the unsteady aerodynamic pressures of oscillating cascade of airfoils representing a blade row of a turbomachinery component. Multiphysics simulation is based on a single computational framework for the modeling of multiple interacting physical phenomena, in the present case being between fluids and structures. Interaction constraints are enforced in a fully coupled manner using the augmented-Lagrangian method. The arbitrary Lagrangian-Eulerian method is utilized to account for deformable fluid domains resulting from blade motions. Unsteady pressures are calculated for a cascade designated as the tenth standard, and undergoing plunging and pitching oscillations. The predicted unsteady pressures are compared with those obtained from an unsteady Euler co-de refer-red in the literature. The Spectrum(TM) code predictions showed good correlation for the cases considered.
ALE3D: An Arbitrary Lagrangian-Eulerian Multi-Physics Code
DOE Office of Scientific and Technical Information (OSTI.GOV)
Noble, Charles R.; Anderson, Andrew T.; Barton, Nathan R.
ALE3D is a multi-physics numerical simulation software tool utilizing arbitrary-Lagrangian- Eulerian (ALE) techniques. The code is written to address both two-dimensional (2D plane and axisymmetric) and three-dimensional (3D) physics and engineering problems using a hybrid finite element and finite volume formulation to model fluid and elastic-plastic response of materials on an unstructured grid. As shown in Figure 1, ALE3D is a single code that integrates many physical phenomena.
GRADSPMHD: A parallel MHD code based on the SPH formalism
NASA Astrophysics Data System (ADS)
Vanaverbeke, S.; Keppens, R.; Poedts, S.
2014-03-01
We present GRADSPMHD, a completely Lagrangian parallel magnetohydrodynamics code based on the SPH formalism. The implementation of the equations of SPMHD in the “GRAD-h” formalism assembles known results, including the derivation of the discretized MHD equations from a variational principle, the inclusion of time-dependent artificial viscosity, resistivity and conductivity terms, as well as the inclusion of a mixed hyperbolic/parabolic correction scheme for satisfying the ∇ṡB→ constraint on the magnetic field. The code uses a tree-based formalism for neighbor finding and can optionally use the tree code for computing the self-gravity of the plasma. The structure of the code closely follows the framework of our parallel GRADSPH FORTRAN 90 code which we added previously to the CPC program library. We demonstrate the capabilities of GRADSPMHD by running 1, 2, and 3 dimensional standard benchmark tests and we find good agreement with previous work done by other researchers. The code is also applied to the problem of simulating the magnetorotational instability in 2.5D shearing box tests as well as in global simulations of magnetized accretion disks. We find good agreement with available results on this subject in the literature. Finally, we discuss the performance of the code on a parallel supercomputer with distributed memory architecture. Catalogue identifier: AERP_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AERP_v1_0.html Program obtainable from: CPC Program Library, Queen’s University, Belfast, N. Ireland Licensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.html No. of lines in distributed program, including test data, etc.: 620503 No. of bytes in distributed program, including test data, etc.: 19837671 Distribution format: tar.gz Programming language: FORTRAN 90/MPI. Computer: HPC cluster. Operating system: Unix. Has the code been vectorized or parallelized?: Yes, parallelized using MPI. RAM: ˜30 MB for a
An approach for coupled-code multiphysics core simulations from a common input
Schmidt, Rodney; Belcourt, Kenneth; Hooper, Russell; ...
2014-12-10
This study describes an approach for coupled-code multiphysics reactor core simulations that is being developed by the Virtual Environment for Reactor Applications (VERA) project in the Consortium for Advanced Simulation of Light-Water Reactors (CASL). In this approach a user creates a single problem description, called the “VERAIn” common input file, to define and setup the desired coupled-code reactor core simulation. A preprocessing step accepts the VERAIn file and generates a set of fully consistent input files for the different physics codes being coupled. The problem is then solved using a single-executable coupled-code simulation tool applicable to the problem, which ismore » built using VERA infrastructure software tools and the set of physics codes required for the problem of interest. The approach is demonstrated by performing an eigenvalue and power distribution calculation of a typical three-dimensional 17 × 17 assembly with thermal–hydraulic and fuel temperature feedback. All neutronics aspects of the problem (cross-section calculation, neutron transport, power release) are solved using the Insilico code suite and are fully coupled to a thermal–hydraulic analysis calculated by the Cobra-TF (CTF) code. The single-executable coupled-code (Insilico-CTF) simulation tool is created using several VERA tools, including LIME (Lightweight Integrating Multiphysics Environment for coupling codes), DTK (Data Transfer Kit), Trilinos, and TriBITS. Parallel calculations are performed on the Titan supercomputer at Oak Ridge National Laboratory using 1156 cores, and a synopsis of the solution results and code performance is presented. Finally, ongoing development of this approach is also briefly described.« less
Salko, Robert K.; Schmidt, Rodney C.; Avramova, Maria N.
2014-11-23
This study describes major improvements to the computational infrastructure of the CTF subchannel code so that full-core, pincell-resolved (i.e., one computational subchannel per real bundle flow channel) simulations can now be performed in much shorter run-times, either in stand-alone mode or as part of coupled-code multi-physics calculations. These improvements support the goals of the Department Of Energy Consortium for Advanced Simulation of Light Water Reactors (CASL) Energy Innovation Hub to develop high fidelity multi-physics simulation tools for nuclear energy design and analysis.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Philip, Bobby
2012-06-01
The Advanced Multi-Physics (AMP) code, in its present form, will allow a user to build a multi-physics application code for existing mechanics and diffusion operators and extend them with user-defined material models and new physics operators. There are examples that demonstrate mechanics, thermo-mechanics, coupled diffusion, and mechanical contact. The AMP code is designed to leverage a variety of mathematical solvers (PETSc, Trilinos, SUNDIALS, and AMP solvers) and mesh databases (LibMesh and AMP) in a consistent interchangeable approach.
FleCSPH - a parallel and distributed SPH implementation based on the FleCSI framework
DOE Office of Scientific and Technical Information (OSTI.GOV)
Junghans, Christoph; Loiseau, Julien
2017-06-20
FleCSPH is a multi-physics compact application that exercises FleCSI parallel data structures for tree-based particle methods. In particular, FleCSPH implements a smoothed-particle hydrodynamics (SPH) solver for the solution of Lagrangian problems in astrophysics and cosmology. FleCSPH includes support for gravitational forces using the fast multipole method (FMM).
The SPH consistency problem and some astrophysical applications
NASA Astrophysics Data System (ADS)
Klapp, Jaime; Sigalotti, Leonardo; Rendon, Otto; Gabbasov, Ruslan; Torres, Ayax
2017-11-01
We discuss the SPH kernel and particle consistency problem and demonstrate that SPH has a limiting second-order convergence rate. We also present a solution to the SPH consistency problem. We present examples of how SPH implementations that are not mathematically consistent may lead to erroneous results. The new formalism has been implemented into the Gadget 2 code, including an improved scheme for the artificial viscosity. We present results for the ``Standard Isothermal Test Case'' of gravitational collapse and fragmentation of protostellar molecular cores that produce a very different evolution than with the standard SPH theory. A further application of accretion onto a black hole is presented.
NASA Astrophysics Data System (ADS)
Ballabio, G.; Dipierro, G.; Veronesi, B.; Lodato, G.; Hutchison, M.; Laibe, G.; Price, D. J.
2018-06-01
We describe a new implementation of the one-fluid method in the SPH code PHANTOM to simulate the dynamics of dust grains in gas protoplanetary discs. We revise and extend previously developed algorithms by computing the evolution of a new fluid quantity that produces a more accurate and numerically controlled evolution of the dust dynamics. Moreover, by limiting the stopping time of uncoupled grains that violate the assumptions of the terminal velocity approximation, we avoid fatal numerical errors in mass conservation. We test and validate our new algorithm by running 3D SPH simulations of a large range of disc models with tightly and marginally coupled grains.
Wandersee, N J; Birkenmeier, C S; Gifford, E J; Mohandas, N; Barker, J E
2000-01-01
Spectrin, a heterodimer of alpha- and beta-subunits, is the major protein component of the red blood cell membrane skeleton. The mouse mutation, sph, causes an alpha-spectrin-deficient hereditary spherocytosis with the severe phenotype typical of recessive hereditary spherocytosis in humans. The sph mutation maps to the erythroid alpha-spectrin locus, Spna1, on Chromosome 1. Scanning electron microscopy, osmotic gradient ektacytometry, cDNA cloning, RT-PCR, nucleic acid sequencing, and Northern blot analyses were used to characterize the wild type and sph alleles of the Spna1 locus. Our results confirm the spherocytic nature of sph/sph red blood cells and document a mild spherocytic transition in the +/sph heterozygotes. Sequencing of the full length coding region of the Spna1 wild type allele from the C57BL/6J strain of mice reveals a 2414 residue deduced amino acid sequence that shows the typical 106-amino-acid repeat structure previously described for other members of the spectrin protein family. Sequence analysis of RT-PCR clones from sph/sph alpha-spectrin mRNA identified a single base deletion in repeat 5 that would cause a frame shift and premature termination of the protein. This deletion was confirmed in sph/sph genomic DNA. Northern blot analyses of the distribution of Spna1 mRNA in non-erythroid tissues detects the expression of 8, 2.5 and 2.0 kb transcripts in adult heart. These results predict the heart as an additional site where alpha-spectrin mutations may produce a phenotype and raise the possibility that a novel functional class of small alpha-spectrin isoforms may exist.
Implementation of the SPH Procedure Within the MOOSE Finite Element Framework
NASA Astrophysics Data System (ADS)
Laurier, Alexandre
. This new method was tested on a simplified model of INL's TREAT reactor, a problem that includes very important graphite reflector regions as well as vacuum boundary conditions with great success. To demonstrate the power of PJFNK SPH on a more common case, the correction was applied to a simplified PWR reactor core from the BEAVRS benchmark that included 15 assemblies and the water reflector to obtain very good results. This opens up the possibility to apply the SPH correction to full reactor cores in order to reduce homogenization errors for use in transient or multi-physics calculations.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Campbell, Michael T.; Safdari, Masoud; Kress, Jessica E.
The project described in this report constructed and exercised an innovative multiphysics coupling toolkit called the Illinois Rocstar MultiPhysics Application Coupling Toolkit (IMPACT). IMPACT is an open source, flexible, natively parallel infrastructure for coupling multiple uniphysics simulation codes into multiphysics computational systems. IMPACT works with codes written in several high-performance-computing (HPC) programming languages, and is designed from the beginning for HPC multiphysics code development. It is designed to be minimally invasive to the individual physics codes being integrated, and has few requirements on those physics codes for integration. The goal of IMPACT is to provide the support needed to enablemore » coupling existing tools together in unique and innovative ways to produce powerful new multiphysics technologies without extensive modification and rewrite of the physics packages being integrated. There are three major outcomes from this project: 1) construction, testing, application, and open-source release of the IMPACT infrastructure, 2) production of example open-source multiphysics tools using IMPACT, and 3) identification and engagement of interested organizations in the tools and applications resulting from the project. This last outcome represents the incipient development of a user community and application echosystem being built using IMPACT. Multiphysics coupling standardization can only come from organizations working together to define needs and processes that span the space of necessary multiphysics outcomes, which Illinois Rocstar plans to continue driving toward. The IMPACT system, including source code, documentation, and test problems are all now available through the public gitHUB.org system to anyone interested in multiphysics code coupling. Many of the basic documents explaining use and architecture of IMPACT are also attached as appendices to this document. Online HTML documentation is available through the git
SPHYNX: an accurate density-based SPH method for astrophysical applications
NASA Astrophysics Data System (ADS)
Cabezón, R. M.; García-Senz, D.; Figueira, J.
2017-10-01
Aims: Hydrodynamical instabilities and shocks are ubiquitous in astrophysical scenarios. Therefore, an accurate numerical simulation of these phenomena is mandatory to correctly model and understand many astrophysical events, such as supernovas, stellar collisions, or planetary formation. In this work, we attempt to address many of the problems that a commonly used technique, smoothed particle hydrodynamics (SPH), has when dealing with subsonic hydrodynamical instabilities or shocks. To that aim we built a new SPH code named SPHYNX, that includes many of the recent advances in the SPH technique and some other new ones, which we present here. Methods: SPHYNX is of Newtonian type and grounded in the Euler-Lagrange formulation of the smoothed-particle hydrodynamics technique. Its distinctive features are: the use of an integral approach to estimating the gradients; the use of a flexible family of interpolators called sinc kernels, which suppress pairing instability; and the incorporation of a new type of volume element which provides a better partition of the unity. Unlike other modern formulations, which consider volume elements linked to pressure, our volume element choice relies on density. SPHYNX is, therefore, a density-based SPH code. Results: A novel computational hydrodynamic code oriented to Astrophysical applications is described, discussed, and validated in the following pages. The ensuing code conserves mass, linear and angular momentum, energy, entropy, and preserves kernel normalization even in strong shocks. In our proposal, the estimation of gradients is enhanced using an integral approach. Additionally, we introduce a new family of volume elements which reduce the so-called tensile instability. Both features help to suppress the damp which often prevents the growth of hydrodynamic instabilities in regular SPH codes. Conclusions: On the whole, SPHYNX has passed the verification tests described below. For identical particle setting and initial
rpSPH: a novel smoothed particle hydrodynamics algorithm
NASA Astrophysics Data System (ADS)
Abel, Tom
2011-05-01
We suggest a novel discretization of the momentum equation for smoothed particle hydrodynamics (SPH) and show that it significantly improves the accuracy of the obtained solutions. Our new formulation which we refer to as relative pressure SPH, rpSPH, evaluates the pressure force with respect to the local pressure. It respects Newton's first law of motion and applies forces to particles only when there is a net force acting upon them. This is in contrast to standard SPH which explicitly uses Newton's third law of motion continuously applying equal but opposite forces between particles. rpSPH does not show the unphysical particle noise, the clumping or banding instability, unphysical surface tension and unphysical scattering of different mass particles found for standard SPH. At the same time, it uses fewer computational operations and only changes a single line in existing SPH codes. We demonstrate its performance on isobaric uniform density distributions, uniform density shearing flows, the Kelvin-Helmholtz and Rayleigh-Taylor instabilities, the Sod shock tube, the Sedov-Taylor blast wave and a cosmological integration of the Santa Barbara galaxy cluster formation test. rpSPH is an improvement in these cases. The improvements come at the cost of giving up exact momentum conservation of the scheme. Consequently, one can also obtain unphysical solutions particularly at low resolutions.
gpuSPHASE-A shared memory caching implementation for 2D SPH using CUDA
NASA Astrophysics Data System (ADS)
Winkler, Daniel; Meister, Michael; Rezavand, Massoud; Rauch, Wolfgang
2017-04-01
Smoothed particle hydrodynamics (SPH) is a meshless Lagrangian method that has been successfully applied to computational fluid dynamics (CFD), solid mechanics and many other multi-physics problems. Using the method to solve transport phenomena in process engineering requires the simulation of several days to weeks of physical time. Based on the high computational demand of CFD such simulations in 3D need a computation time of years so that a reduction to a 2D domain is inevitable. In this paper gpuSPHASE, a new open-source 2D SPH solver implementation for graphics devices, is developed. It is optimized for simulations that must be executed with thousands of frames per second to be computed in reasonable time. A novel caching algorithm for Compute Unified Device Architecture (CUDA) shared memory is proposed and implemented. The software is validated and the performance is evaluated for the well established dambreak test case.
Computation of Thermodynamic Equilibria Pertinent to Nuclear Materials in Multi-Physics Codes
NASA Astrophysics Data System (ADS)
Piro, Markus Hans Alexander
Nuclear energy plays a vital role in supporting electrical needs and fulfilling commitments to reduce greenhouse gas emissions. Research is a continuing necessity to improve the predictive capabilities of fuel behaviour in order to reduce costs and to meet increasingly stringent safety requirements by the regulator. Moreover, a renewed interest in nuclear energy has given rise to a "nuclear renaissance" and the necessity to design the next generation of reactors. In support of this goal, significant research efforts have been dedicated to the advancement of numerical modelling and computational tools in simulating various physical and chemical phenomena associated with nuclear fuel behaviour. This undertaking in effect is collecting the experience and observations of a past generation of nuclear engineers and scientists in a meaningful way for future design purposes. There is an increasing desire to integrate thermodynamic computations directly into multi-physics nuclear fuel performance and safety codes. A new equilibrium thermodynamic solver is being developed with this matter as a primary objective. This solver is intended to provide thermodynamic material properties and boundary conditions for continuum transport calculations. There are several concerns with the use of existing commercial thermodynamic codes: computational performance; limited capabilities in handling large multi-component systems of interest to the nuclear industry; convenient incorporation into other codes with quality assurance considerations; and, licensing entanglements associated with code distribution. The development of this software in this research is aimed at addressing all of these concerns. The approach taken in this work exploits fundamental principles of equilibrium thermodynamics to simplify the numerical optimization equations. In brief, the chemical potentials of all species and phases in the system are constrained by estimates of the chemical potentials of the system
DOE Office of Scientific and Technical Information (OSTI.GOV)
Matthew Ellis; Derek Gaston; Benoit Forget
In recent years the use of Monte Carlo methods for modeling reactors has become feasible due to the increasing availability of massively parallel computer systems. One of the primary challenges yet to be fully resolved, however, is the efficient and accurate inclusion of multiphysics feedback in Monte Carlo simulations. The research in this paper presents a preliminary coupling of the open source Monte Carlo code OpenMC with the open source Multiphysics Object-Oriented Simulation Environment (MOOSE). The coupling of OpenMC and MOOSE will be used to investigate efficient and accurate numerical methods needed to include multiphysics feedback in Monte Carlo codes.more » An investigation into the sensitivity of Doppler feedback to fuel temperature approximations using a two dimensional 17x17 PWR fuel assembly is presented in this paper. The results show a functioning multiphysics coupling between OpenMC and MOOSE. The coupling utilizes Functional Expansion Tallies to accurately and efficiently transfer pin power distributions tallied in OpenMC to unstructured finite element meshes used in MOOSE. The two dimensional PWR fuel assembly case also demonstrates that for a simplified model the pin-by-pin doppler feedback can be adequately replicated by scaling a representative pin based on pin relative powers.« less
Ihmsen, Markus; Cornelis, Jens; Solenthaler, Barbara; Horvath, Christopher; Teschner, Matthias
2013-07-25
We propose a novel formulation of the projection method for Smoothed Particle Hydrodynamics (SPH). We combine a symmetric SPH pressure force and an SPH discretization of the continuity equation to obtain a discretized form of the pressure Poisson equation (PPE). In contrast to previous projection schemes, our system does consider the actual computation of the pressure force. This incorporation improves the convergence rate of the solver. Furthermore, we propose to compute the density deviation based on velocities instead of positions as this formulation improves the robustness of the time-integration scheme. We show that our novel formulation outperforms previous projection schemes and state-of-the-art SPH methods. Large time steps and small density deviations of down to 0.01% can be handled in typical scenarios. The practical relevance of the approach is illustrated by scenarios with up to 40 million SPH particles.
Ihmsen, Markus; Cornelis, Jens; Solenthaler, Barbara; Horvath, Christopher; Teschner, Matthias
2014-03-01
We propose a novel formulation of the projection method for Smoothed Particle Hydrodynamics (SPH). We combine a symmetric SPH pressure force and an SPH discretization of the continuity equation to obtain a discretized form of the pressure Poisson equation (PPE). In contrast to previous projection schemes, our system does consider the actual computation of the pressure force. This incorporation improves the convergence rate of the solver. Furthermore, we propose to compute the density deviation based on velocities instead of positions as this formulation improves the robustness of the time-integration scheme. We show that our novel formulation outperforms previous projection schemes and state-of-the-art SPH methods. Large time steps and small density deviations of down to 0.01 percent can be handled in typical scenarios. The practical relevance of the approach is illustrated by scenarios with up to 40 million SPH particles.
Direct collapse to supermassive black hole seeds: comparing the AMR and SPH approaches.
Luo, Yang; Nagamine, Kentaro; Shlosman, Isaac
2016-07-01
We provide detailed comparison between the adaptive mesh refinement (AMR) code enzo-2.4 and the smoothed particle hydrodynamics (SPH)/ N -body code gadget-3 in the context of isolated or cosmological direct baryonic collapse within dark matter (DM) haloes to form supermassive black holes. Gas flow is examined by following evolution of basic parameters of accretion flows. Both codes show an overall agreement in the general features of the collapse; however, many subtle differences exist. For isolated models, the codes increase their spatial and mass resolutions at different pace, which leads to substantially earlier collapse in SPH than in AMR cases due to higher gravitational resolution in gadget-3. In cosmological runs, the AMR develops a slightly higher baryonic resolution than SPH during halo growth via cold accretion permeated by mergers. Still, both codes agree in the build-up of DM and baryonic structures. However, with the onset of collapse, this difference in mass and spatial resolution is amplified, so evolution of SPH models begins to lag behind. Such a delay can have effect on formation/destruction rate of H 2 due to UV background, and on basic properties of host haloes. Finally, isolated non-cosmological models in spinning haloes, with spin parameter λ ∼ 0.01-0.07, show delayed collapse for greater λ, but pace of this increase is faster for AMR. Within our simulation set-up, gadget-3 requires significantly larger computational resources than enzo-2.4 during collapse, and needs similar resources, during the pre-collapse, cosmological structure formation phase. Yet it benefits from substantially higher gravitational force and hydrodynamic resolutions, except at the end of collapse.
Direct collapse to supermassive black hole seeds: comparing the AMR and SPH approaches
NASA Astrophysics Data System (ADS)
Luo, Yang; Nagamine, Kentaro; Shlosman, Isaac
2016-07-01
We provide detailed comparison between the adaptive mesh refinement (AMR) code ENZO-2.4 and the smoothed particle hydrodynamics (SPH)/N-body code GADGET-3 in the context of isolated or cosmological direct baryonic collapse within dark matter (DM) haloes to form supermassive black holes. Gas flow is examined by following evolution of basic parameters of accretion flows. Both codes show an overall agreement in the general features of the collapse; however, many subtle differences exist. For isolated models, the codes increase their spatial and mass resolutions at different pace, which leads to substantially earlier collapse in SPH than in AMR cases due to higher gravitational resolution in GADGET-3. In cosmological runs, the AMR develops a slightly higher baryonic resolution than SPH during halo growth via cold accretion permeated by mergers. Still, both codes agree in the build-up of DM and baryonic structures. However, with the onset of collapse, this difference in mass and spatial resolution is amplified, so evolution of SPH models begins to lag behind. Such a delay can have effect on formation/destruction rate of H2 due to UV background, and on basic properties of host haloes. Finally, isolated non-cosmological models in spinning haloes, with spin parameter λ ˜ 0.01-0.07, show delayed collapse for greater λ, but pace of this increase is faster for AMR. Within our simulation set-up, GADGET-3 requires significantly larger computational resources than ENZO-2.4 during collapse, and needs similar resources, during the pre-collapse, cosmological structure formation phase. Yet it benefits from substantially higher gravitational force and hydrodynamic resolutions, except at the end of collapse.
SPH non-Newtonian Model for Ice Sheet and Ice Shelf Dynamics
DOE Office of Scientific and Technical Information (OSTI.GOV)
Tartakovsky, Alexandre M.; Pan, Wenxiao; Monaghan, Joseph J.
2012-07-07
We propose a new three-dimensional smoothed particle hydrodynamics (SPH) non-Newtonian model to study coupled ice sheet and ice shelf dynamics. Most existing ice sheet numerical models use a grid-based Eulerian approach, and are usually restricted to shallow ice sheet and ice shelf approximations of the momentum conservation equation. SPH, a fully Lagrangian particle method, solves the full momentum conservation equation. SPH method also allows modeling of free-surface flows, large material deformation, and material fragmentation without employing complex front-tracking schemes, and does not require re-meshing. As a result, SPH codes are highly scalable. Numerical accuracy of the proposed SPH model ismore » first verified by simulating a plane shear flow with a free surface and the propagation of a blob of ice along a horizontal surface. Next, the SPH model is used to investigate the grounding line dynamics of ice sheet/shelf. The steady position of the grounding line, obtained from our SPH simulations, is in good agreement with laboratory observations for a wide range of bedrock slopes, ice-to-fluid density ratios, and flux. We examine the effect of non-Newtonian behavior of ice on the grounding line dynamics. The non-Newtonian constitutive model is based on Glen's law for a creeping flow of a polycrystalline ice. Finally, we investigate the effect of a bedrock geometry on a steady-state position of the grounding line.« less
DOE Office of Scientific and Technical Information (OSTI.GOV)
Valdarnini, R., E-mail: valda@sissa.it
In this paper, we present results from a series of hydrodynamical tests aimed at validating the performance of a smoothed particle hydrodynamics (SPH) formulation in which gradients are derived from an integral approach. We specifically investigate the code behavior with subsonic flows, where it is well known that zeroth-order inconsistencies present in standard SPH make it particularly problematic to correctly model the fluid dynamics. In particular, we consider the Gresho–Chan vortex problem, the growth of Kelvin–Helmholtz instabilities, the statistics of driven subsonic turbulence and the cold Keplerian disk problem. We compare simulation results for the different tests with those obtained,more » for the same initial conditions, using standard SPH. We also compare the results with the corresponding ones obtained previously with other numerical methods, such as codes based on a moving-mesh scheme or Godunov-type Lagrangian meshless methods. We quantify code performances by introducing error norms and spectral properties of the particle distribution, in a way similar to what was done in other works. We find that the new SPH formulation exhibits strongly reduced gradient errors and outperforms standard SPH in all of the tests considered. In fact, in terms of accuracy, we find good agreement between the simulation results of the new scheme and those produced using other recently proposed numerical schemes. These findings suggest that the proposed method can be successfully applied for many astrophysical problems in which the presence of subsonic flows previously limited the use of SPH, with the new scheme now being competitive in these regimes with other numerical methods.« less
SEURAT: SPH scheme extended with ultraviolet line radiative transfer
NASA Astrophysics Data System (ADS)
Abe, Makito; Suzuki, Hiroyuki; Hasegawa, Kenji; Semelin, Benoit; Yajima, Hidenobu; Umemura, Masayuki
2018-05-01
We present a novel Lyman alpha (Ly α) radiative transfer code, SEURAT (SPH scheme Extended with Ultraviolet line RAdiative Transfer), where line scatterings are solved adaptively with the resolution of the smoothed particle hydrodynamics (SPH). The radiative transfer method implemented in SEURAT is based on a Monte Carlo algorithm in which the scattering and absorption by dust are also incorporated. We perform standard test calculations to verify the validity of the code; (i) emergent spectra from a static uniform sphere, (ii) emergent spectra from an expanding uniform sphere, and (iii) escape fraction from a dusty slab. Thereby, we demonstrate that our code solves the {Ly} α radiative transfer with sufficient accuracy. We emphasize that SEURAT can treat the transfer of {Ly} α photons even in highly complex systems that have significantly inhomogeneous density fields. The high adaptivity of SEURAT is desirable to solve the propagation of {Ly} α photons in the interstellar medium of young star-forming galaxies like {Ly} α emitters (LAEs). Thus, SEURAT provides a powerful tool to model the emergent spectra of {Ly} α emission, which can be compared to the observations of LAEs.
A shock-capturing SPH scheme based on adaptive kernel estimation
NASA Astrophysics Data System (ADS)
Sigalotti, Leonardo Di G.; López, Hender; Donoso, Arnaldo; Sira, Eloy; Klapp, Jaime
2006-02-01
Here we report a method that converts standard smoothed particle hydrodynamics (SPH) into a working shock-capturing scheme without relying on solutions to the Riemann problem. Unlike existing adaptive SPH simulations, the present scheme is based on an adaptive kernel estimation of the density, which combines intrinsic features of both the kernel and nearest neighbor approaches in a way that the amount of smoothing required in low-density regions is effectively controlled. Symmetrized SPH representations of the gas dynamic equations along with the usual kernel summation for the density are used to guarantee variational consistency. Implementation of the adaptive kernel estimation involves a very simple procedure and allows for a unique scheme that handles strong shocks and rarefactions the same way. Since it represents a general improvement of the integral interpolation on scattered data, it is also applicable to other fluid-dynamic models. When the method is applied to supersonic compressible flows with sharp discontinuities, as in the classical one-dimensional shock-tube problem and its variants, the accuracy of the results is comparable, and in most cases superior, to that obtained from high quality Godunov-type methods and SPH formulations based on Riemann solutions. The extension of the method to two- and three-space dimensions is straightforward. In particular, for the two-dimensional cylindrical Noh's shock implosion and Sedov point explosion problems the present scheme produces much better results than those obtained with conventional SPH codes.
SPH simulations of high-speed collisions
NASA Astrophysics Data System (ADS)
Rozehnal, Jakub; Broz, Miroslav
2016-10-01
Our work is devoted to a comparison of: i) asteroid-asteroid collisions occurring at lower velocities (about 5 km/s in the Main Belt), and ii) mutual collisions of asteroids and cometary nuclei usually occurring at significantly higher relative velocities (> 10 km/s).We focus on differences in the propagation of the shock wave, ejection of the fragments and possible differences in the resultingsize-frequency distributions of synthetic asteroid families. We also discuss scaling with respect to the "nominal" target diameter D = 100 km, projectile velocity 3-7 km/s, for which a number of simulations were done so far (Durda et al. 2007, Benavidez et al. 2012).In the latter case of asteroid-comet collisions, we simulate the impacts of brittle or pre-damaged impactors onto solid monolithic targets at high velocities, ranging from 10 to 15 km/s. The purpose of this numerical experiment is to better understand impact processes shaping the early Solar System, namely the primordial asteroid belt during during the (late) heavy bombardment (as a continuation of Broz et al. 2013).For all hydrodynamical simulations we use a smoothed-particle hydrodynamics method (SPH), namely the lagrangian SPH3D code (Benz & Asphaug 1994, 1995). The gravitational interactions between fragments (re-accumulation) is simulated with the Pkdgrav tree-code (Richardson et al. 2000).
A hybrid Lagrangian Voronoi-SPH scheme
NASA Astrophysics Data System (ADS)
Fernandez-Gutierrez, D.; Souto-Iglesias, A.; Zohdi, T. I.
2018-07-01
A hybrid Lagrangian Voronoi-SPH scheme, with an explicit weakly compressible formulation for both the Voronoi and SPH sub-domains, has been developed. The SPH discretization is substituted by Voronoi elements close to solid boundaries, where SPH consistency and boundary conditions implementation become problematic. A buffer zone to couple the dynamics of both sub-domains is used. This zone is formed by a set of particles where fields are interpolated taking into account SPH particles and Voronoi elements. A particle may move in or out of the buffer zone depending on its proximity to a solid boundary. The accuracy of the coupled scheme is discussed by means of a set of well-known verification benchmarks.
A hybrid Lagrangian Voronoi-SPH scheme
NASA Astrophysics Data System (ADS)
Fernandez-Gutierrez, D.; Souto-Iglesias, A.; Zohdi, T. I.
2017-11-01
A hybrid Lagrangian Voronoi-SPH scheme, with an explicit weakly compressible formulation for both the Voronoi and SPH sub-domains, has been developed. The SPH discretization is substituted by Voronoi elements close to solid boundaries, where SPH consistency and boundary conditions implementation become problematic. A buffer zone to couple the dynamics of both sub-domains is used. This zone is formed by a set of particles where fields are interpolated taking into account SPH particles and Voronoi elements. A particle may move in or out of the buffer zone depending on its proximity to a solid boundary. The accuracy of the coupled scheme is discussed by means of a set of well-known verification benchmarks.
SPH modeling of fluid-structure interaction
NASA Astrophysics Data System (ADS)
Han, Luhui; Hu, Xiangyu
2018-02-01
This work concerns numerical modeling of fluid-structure interaction (FSI) problems in a uniform smoothed particle hydrodynamics (SPH) framework. It combines a transport-velocity SPH scheme, advancing fluid motions, with a total Lagrangian SPH formulation dealing with the structure deformations. Since both fluid and solid governing equations are solved in SPH framework, while coupling becomes straightforward, the momentum conservation of the FSI system is satisfied strictly. A well-known FSI benchmark test case has been performed to validate the modeling and to demonstrate its potential.
A Comparison of Grid-based and SPH Binary Mass-transfer and Merger Simulations
Motl, Patrick M.; Frank, Juhan; Staff, Jan; ...
2017-03-29
There is currently a great amount of interest in the outcomes and astrophysical implications of mergers of double degenerate binaries. In a commonly adopted approximation, the components of such binaries are represented by polytropes with an index of n = 3/2. We present detailed comparisons of stellar mass-transfer and merger simulations of polytropic binaries that have been carried out using two very different numerical algorithms—a finite-volume "grid" code and a smoothed-particle hydrodynamics (SPH) code. We find that there is agreement in both the ultimate outcomes of the evolutions and the intermediate stages if the initial conditions for each code aremore » chosen to match as closely as possible. We find that even with closely matching initial setups, the time it takes to reach a concordant evolution differs between the two codes because the initial depth of contact cannot be matched exactly. There is a general tendency for SPH to yield higher mass transfer rates and faster evolution to the final outcome. Here, we also present comparisons of simulations calculated from two different energy equations: in one series, we assume a polytropic equation of state and in the other series an ideal gas equation of state. In the latter series of simulations, an atmosphere forms around the accretor, which can exchange angular momentum and cause a more rapid loss of orbital angular momentum. In the simulations presented here, the effect of the ideal equation of state is to de-stabilize the binary in both SPH and grid simulations, but the effect is more pronounced in the grid code.« less
A Comparison of Grid-based and SPH Binary Mass-transfer and Merger Simulations
DOE Office of Scientific and Technical Information (OSTI.GOV)
Motl, Patrick M.; Frank, Juhan; Clayton, Geoffrey C.
2017-04-01
There is currently a great amount of interest in the outcomes and astrophysical implications of mergers of double degenerate binaries. In a commonly adopted approximation, the components of such binaries are represented by polytropes with an index of n = 3/2. We present detailed comparisons of stellar mass-transfer and merger simulations of polytropic binaries that have been carried out using two very different numerical algorithms—a finite-volume “grid” code and a smoothed-particle hydrodynamics (SPH) code. We find that there is agreement in both the ultimate outcomes of the evolutions and the intermediate stages if the initial conditions for each code are chosen to matchmore » as closely as possible. We find that even with closely matching initial setups, the time it takes to reach a concordant evolution differs between the two codes because the initial depth of contact cannot be matched exactly. There is a general tendency for SPH to yield higher mass transfer rates and faster evolution to the final outcome. We also present comparisons of simulations calculated from two different energy equations: in one series, we assume a polytropic equation of state and in the other series an ideal gas equation of state. In the latter series of simulations, an atmosphere forms around the accretor, which can exchange angular momentum and cause a more rapid loss of orbital angular momentum. In the simulations presented here, the effect of the ideal equation of state is to de-stabilize the binary in both SPH and grid simulations, but the effect is more pronounced in the grid code.« less
Dimension reduction method for SPH equations
DOE Office of Scientific and Technical Information (OSTI.GOV)
Tartakovsky, Alexandre M.; Scheibe, Timothy D.
2011-08-26
Smoothed Particle Hydrodynamics model of a complex multiscale processe often results in a system of ODEs with an enormous number of unknowns. Furthermore, a time integration of the SPH equations usually requires time steps that are smaller than the observation time by many orders of magnitude. A direct solution of these ODEs can be extremely expensive. Here we propose a novel dimension reduction method that gives an approximate solution of the SPH ODEs and provides an accurate prediction of the average behavior of the modeled system. The method consists of two main elements. First, effective equationss for evolution of averagemore » variables (e.g. average velocity, concentration and mass of a mineral precipitate) are obtained by averaging the SPH ODEs over the entire computational domain. These effective ODEs contain non-local terms in the form of volume integrals of functions of the SPH variables. Second, a computational closure is used to close the system of the effective equations. The computational closure is achieved via short bursts of the SPH model. The dimension reduction model is used to simulate flow and transport with mixing controlled reactions and mineral precipitation. An SPH model is used model transport at the porescale. Good agreement between direct solutions of the SPH equations and solutions obtained with the dimension reduction method for different boundary conditions confirms the accuracy and computational efficiency of the dimension reduction model. The method significantly accelerates SPH simulations, while providing accurate approximation of the solution and accurate prediction of the average behavior of the system.« less
Fan, Xiaochen; Yuan, Jishan; Xie, Jun; Pan, Zhanpeng; Yao, Xiang; Sun, Xiangyi; Zhang, Pin; Zhang, Lei
2018-06-07
Long noncoding RNAs (lncRNAs) have been known to be involved in multiple diverse diseases, including osteoarthritis (OA). This study aimed to explore the role of differentiation antagonizing non-protein coding RNA (DANCR) in OA and identify the potential molecular mechanisms. The expression of DANCR in cartilage samples from patients with OA was detected using quantitative reverse transcription-polymerase chain reaction. The effects of DANCR on the viability of OA chondrocytes and apoptosis were explored using cell counting kit 8 assay and flow cytometry assay, respectively. Additionally, the interaction among DANCR, miR-577, and SphK2 was explored using dual-luciferase reporter and RIP assays. The present study found that DANCR was significantly upregulated in patients with OA. Functional assays demonstrated that DANCR inhibition suppressed the proliferation of OA chondrocytes and induced cell apoptosis. The study also showed that DANCR acted as a competitive endogenous RNA to sponge miR-577, which targeted the mRNA of SphK2 to regulate the survival of OA chondrocytes. In conclusion, the study revealed that lncRNA DANCR might promote the proliferation of OA chondrocytes and reduce apoptosis through the miR-577/SphK2 axis. Thus, lncRNA DANCR might be considered as a potential therapeutic target for OA treatment. Copyright © 2018 Elsevier Inc. All rights reserved.
Advanced multiphysics coupling for LWR fuel performance analysis
Hales, J. D.; Tonks, M. R.; Gleicher, F. N.; ...
2015-10-01
Even the most basic nuclear fuel analysis is a multiphysics undertaking, as a credible simulation must consider at a minimum coupled heat conduction and mechanical deformation. The need for more realistic fuel modeling under a variety of conditions invariably leads to a desire to include coupling between a more complete set of the physical phenomena influencing fuel behavior, including neutronics, thermal hydraulics, and mechanisms occurring at lower length scales. This paper covers current efforts toward coupled multiphysics LWR fuel modeling in three main areas. The first area covered in this paper concerns thermomechanical coupling. The interaction of these two physics,more » particularly related to the feedback effect associated with heat transfer and mechanical contact at the fuel/clad gap, provides numerous computational challenges. An outline is provided of an effective approach used to manage the nonlinearities associated with an evolving gap in BISON, a nuclear fuel performance application. A second type of multiphysics coupling described here is that of coupling neutronics with thermomechanical LWR fuel performance. DeCART, a high-fidelity core analysis program based on the method of characteristics, has been coupled to BISON. DeCART provides sub-pin level resolution of the multigroup neutron flux, with resonance treatment, during a depletion or a fast transient simulation. Two-way coupling between these codes was achieved by mapping fission rate density and fast neutron flux fields from DeCART to BISON and the temperature field from BISON to DeCART while employing a Picard iterative algorithm. Finally, the need for multiscale coupling is considered. Fission gas production and evolution significantly impact fuel performance by causing swelling, a reduction in the thermal conductivity, and fission gas release. The mechanisms involved occur at the atomistic and grain scale and are therefore not the domain of a fuel performance code. However, it is
DOE Office of Scientific and Technical Information (OSTI.GOV)
Saad, Tony; Sutherland, James C.
To address the coding and software challenges of modern hybrid architectures, we propose an approach to multiphysics code development for high-performance computing. This approach is based on using a Domain Specific Language (DSL) in tandem with a directed acyclic graph (DAG) representation of the problem to be solved that allows runtime algorithm generation. When coupled with a large-scale parallel framework, the result is a portable development framework capable of executing on hybrid platforms and handling the challenges of multiphysics applications. In addition, we share our experience developing a code in such an environment – an effort that spans an interdisciplinarymore » team of engineers and computer scientists.« less
Saad, Tony; Sutherland, James C.
2016-05-04
To address the coding and software challenges of modern hybrid architectures, we propose an approach to multiphysics code development for high-performance computing. This approach is based on using a Domain Specific Language (DSL) in tandem with a directed acyclic graph (DAG) representation of the problem to be solved that allows runtime algorithm generation. When coupled with a large-scale parallel framework, the result is a portable development framework capable of executing on hybrid platforms and handling the challenges of multiphysics applications. In addition, we share our experience developing a code in such an environment – an effort that spans an interdisciplinarymore » team of engineers and computer scientists.« less
Multi-phase SPH modelling of violent hydrodynamics on GPUs
NASA Astrophysics Data System (ADS)
Mokos, Athanasios; Rogers, Benedict D.; Stansby, Peter K.; Domínguez, José M.
2015-11-01
This paper presents the acceleration of multi-phase smoothed particle hydrodynamics (SPH) using a graphics processing unit (GPU) enabling large numbers of particles (10-20 million) to be simulated on just a single GPU card. With novel hardware architectures such as a GPU, the optimum approach to implement a multi-phase scheme presents some new challenges. Many more particles must be included in the calculation and there are very different speeds of sound in each phase with the largest speed of sound determining the time step. This requires efficient computation. To take full advantage of the hardware acceleration provided by a single GPU for a multi-phase simulation, four different algorithms are investigated: conditional statements, binary operators, separate particle lists and an intermediate global function. Runtime results show that the optimum approach needs to employ separate cell and neighbour lists for each phase. The profiler shows that this approach leads to a reduction in both memory transactions and arithmetic operations giving significant runtime gains. The four different algorithms are compared to the efficiency of the optimised single-phase GPU code, DualSPHysics, for 2-D and 3-D simulations which indicate that the multi-phase functionality has a significant computational overhead. A comparison with an optimised CPU code shows a speed up of an order of magnitude over an OpenMP simulation with 8 threads and two orders of magnitude over a single thread simulation. A demonstration of the multi-phase SPH GPU code is provided by a 3-D dam break case impacting an obstacle. This shows better agreement with experimental results than an equivalent single-phase code. The multi-phase GPU code enables a convergence study to be undertaken on a single GPU with a large number of particles that otherwise would have required large high performance computing resources.
A multiphysics and multiscale software environment for modeling astrophysical systems
NASA Astrophysics Data System (ADS)
Portegies Zwart, Simon; McMillan, Steve; Harfst, Stefan; Groen, Derek; Fujii, Michiko; Nualláin, Breanndán Ó.; Glebbeek, Evert; Heggie, Douglas; Lombardi, James; Hut, Piet; Angelou, Vangelis; Banerjee, Sambaran; Belkus, Houria; Fragos, Tassos; Fregeau, John; Gaburov, Evghenii; Izzard, Rob; Jurić, Mario; Justham, Stephen; Sottoriva, Andrea; Teuben, Peter; van Bever, Joris; Yaron, Ofer; Zemp, Marcel
2009-05-01
We present MUSE, a software framework for combining existing computational tools for different astrophysical domains into a single multiphysics, multiscale application. MUSE facilitates the coupling of existing codes written in different languages by providing inter-language tools and by specifying an interface between each module and the framework that represents a balance between generality and computational efficiency. This approach allows scientists to use combinations of codes to solve highly coupled problems without the need to write new codes for other domains or significantly alter their existing codes. MUSE currently incorporates the domains of stellar dynamics, stellar evolution and stellar hydrodynamics for studying generalized stellar systems. We have now reached a "Noah's Ark" milestone, with (at least) two available numerical solvers for each domain. MUSE can treat multiscale and multiphysics systems in which the time- and size-scales are well separated, like simulating the evolution of planetary systems, small stellar associations, dense stellar clusters, galaxies and galactic nuclei. In this paper we describe three examples calculated using MUSE: the merger of two galaxies, the merger of two evolving stars, and a hybrid N-body simulation. In addition, we demonstrate an implementation of MUSE on a distributed computer which may also include special-purpose hardware, such as GRAPEs or GPUs, to accelerate computations. The current MUSE code base is publicly available as open source at http://muse.li.
NASA Astrophysics Data System (ADS)
Fourtakas, G.; Rogers, B. D.
2016-06-01
A two-phase numerical model using Smoothed Particle Hydrodynamics (SPH) is applied to two-phase liquid-sediments flows. The absence of a mesh in SPH is ideal for interfacial and highly non-linear flows with changing fragmentation of the interface, mixing and resuspension. The rheology of sediment induced under rapid flows undergoes several states which are only partially described by previous research in SPH. This paper attempts to bridge the gap between the geotechnics, non-Newtonian and Newtonian flows by proposing a model that combines the yielding, shear and suspension layer which are needed to predict accurately the global erosion phenomena, from a hydrodynamics prospective. The numerical SPH scheme is based on the explicit treatment of both phases using Newtonian and the non-Newtonian Bingham-type Herschel-Bulkley-Papanastasiou constitutive model. This is supplemented by the Drucker-Prager yield criterion to predict the onset of yielding of the sediment surface and a concentration suspension model. The multi-phase model has been compared with experimental and 2-D reference numerical models for scour following a dry-bed dam break yielding satisfactory results and improvements over well-known SPH multi-phase models. With 3-D simulations requiring a large number of particles, the code is accelerated with a graphics processing unit (GPU) in the open-source DualSPHysics code. The implementation and optimisation of the code achieved a speed up of x58 over an optimised single thread serial code. A 3-D dam break over a non-cohesive erodible bed simulation with over 4 million particles yields close agreement with experimental scour and water surface profiles.
Multidimensional Multiphysics Simulation of TRISO Particle Fuel
DOE Office of Scientific and Technical Information (OSTI.GOV)
J. D. Hales; R. L. Williamson; S. R. Novascone
2013-11-01
Multidimensional multiphysics analysis of TRISO-coated particle fuel using the BISON finite-element based nuclear fuels code is described. The governing equations and material models applicable to particle fuel and implemented in BISON are outlined. Code verification based on a recent IAEA benchmarking exercise is described, and excellant comparisons are reported. Multiple TRISO-coated particles of increasing geometric complexity are considered. It is shown that the code's ability to perform large-scale parallel computations permits application to complex 3D phenomena while very efficient solutions for either 1D spherically symmetric or 2D axisymmetric geometries are straightforward. Additionally, the flexibility to easily include new physical andmore » material models and uncomplicated ability to couple to lower length scale simulations makes BISON a powerful tool for simulation of coated-particle fuel. Future code development activities and potential applications are identified.« less
Dependency graph for code analysis on emerging architectures
DOE Office of Scientific and Technical Information (OSTI.GOV)
Shashkov, Mikhail Jurievich; Lipnikov, Konstantin
Direct acyclic dependency (DAG) graph is becoming the standard for modern multi-physics codes.The ideal DAG is the true block-scheme of a multi-physics code. Therefore, it is the convenient object for insitu analysis of the cost of computations and algorithmic bottlenecks related to statistical frequent data motion and dymanical machine state.
Multi-physics CFD simulations in engineering
NASA Astrophysics Data System (ADS)
Yamamoto, Makoto
2013-08-01
Nowadays Computational Fluid Dynamics (CFD) software is adopted as a design and analysis tool in a great number of engineering fields. We can say that single-physics CFD has been sufficiently matured in the practical point of view. The main target of existing CFD software is single-phase flows such as water and air. However, many multi-physics problems exist in engineering. Most of them consist of flow and other physics, and the interactions between different physics are very important. Obviously, multi-physics phenomena are critical in developing machines and processes. A multi-physics phenomenon seems to be very complex, and it is so difficult to be predicted by adding other physics to flow phenomenon. Therefore, multi-physics CFD techniques are still under research and development. This would be caused from the facts that processing speed of current computers is not fast enough for conducting a multi-physics simulation, and furthermore physical models except for flow physics have not been suitably established. Therefore, in near future, we have to develop various physical models and efficient CFD techniques, in order to success multi-physics simulations in engineering. In the present paper, I will describe the present states of multi-physics CFD simulations, and then show some numerical results such as ice accretion and electro-chemical machining process of a three-dimensional compressor blade which were obtained in my laboratory. Multi-physics CFD simulations would be a key technology in near future.
Multiphysics Simulations: Challenges and Opportunities
DOE Office of Scientific and Technical Information (OSTI.GOV)
Keyes, David; McInnes, Lois C.; Woodward, Carol
2013-02-12
We consider multiphysics applications from algorithmic and architectural perspectives, where ‘‘algorithmic’’ includes both mathematical analysis and computational complexity, and ‘‘architectural’’ includes both software and hardware environments. Many diverse multiphysics applications can be reduced, en route to their computational simulation, to a common algebraic coupling paradigm. Mathematical analysis of multiphysics coupling in this form is not always practical for realistic applications, but model problems representative of applications discussed herein can provide insight. A variety of software frameworks for multiphysics applications have been constructed and refined within disciplinary communities and executed on leading-edge computer systems. We examine several of these, expose somemore » commonalities among them, and attempt to extrapolate best practices to future systems. From our study, we summarize challenges and forecast opportunities.« less
Gas stripping in galaxy clusters: a new SPH simulation approach
NASA Astrophysics Data System (ADS)
Jáchym, P.; Palouš, J.; Köppen, J.; Combes, F.
2007-09-01
Aims:The influence of a time-varying ram pressure on spiral galaxies in clusters is explored with a new simulation method based on the N-body SPH/tree code GADGET. Methods: We have adapted the code to describe the interaction of two different gas phases, the diffuse hot intracluster medium (ICM) and the denser and colder interstellar medium (ISM). Both the ICM and ISM components are introduced as SPH particles. As a galaxy arrives on a highly radial orbit from outskirts to cluster center, it crosses the ICM density peak and experiences a time-varying wind. Results: Depending on the duration and intensity of the ISM-ICM interaction, early and late type galaxies in galaxy clusters with either a large or small ICM distribution are found to show different stripping efficiencies, amounts of reaccretion of the extra-planar ISM, and final masses. We compare the numerical results with analytical approximations of different complexity and indicate the limits of the Gunn & Gott simple stripping formula. Conclusions: Our investigations emphasize the role of the galactic orbital history to the stripping amount. We discuss the contribution of ram pressure stripping to the origin of the ICM and its metallicity. We propose gas accumulations like tails, filaments, or ripples to be responsible for stripping in regions with low overall ICM occurrence. Appendix A is only available in electronic form at http://www.aanda.org
Lin, Chun-Yu; Hu, Kuang-Yu; Ho, Shih-Hu; Song, Yen-Ling
2006-01-01
Clip domain serine protease homologs (c-SPHs) are involved in various innate immune functions in arthropods such as antimicrobial activity, cell adhesion, pattern recognition, opsonization, and regulation of the prophenoloxidase system. In the present study, we cloned a c-SPH cDNA from tiger shrimp (Penaeus monodon) hemocytes. It is 1337 bp in length with a coding region of 1068 bp consisting a protein of 355 amino acid residues. The deduced protein includes one clip domain and one catalytically inactive serine protease-like (SP-like) domain. Its molecular weight is estimated to be 38 kDa with an isoelectric point of 7.9. The predicted cutting site of the signal peptide is located between Gly(21) and Gln(22). We aligned 15 single clip domain SPH protein sequences from 12 arthropod species; the identity of these clip domains is low and that of SP-like domains is from 34% to 46%. The conserved regions are located near the amino acid residues which served as substrate interaction sites in catalytically active serine protease. Phylogenetically, the tiger shrimp c-SPH is most similar to a low molecular mass masquerade-like protein of crayfish, but less similar to c-SPHs in Chelicerata and Insecta. Nested reverse transcription polymerase chain reaction (RT-PCR) revealed that c-SPH mRNA is expressed most in tissues with the highest hemocyte abundance. Antimicrobial and opsonization activities of the molecule were not detected. The expression of c-SPH mRNA in hemocytes was up-regulated at the 12-day post beta-glucan immersion. Recombinant c-SPH could significantly enhance hemocyte adhesion. The result suggests that the shrimp c-SPH protein plays a role in innate immunity.
Integration of Advanced Probabilistic Analysis Techniques with Multi-Physics Models
DOE Office of Scientific and Technical Information (OSTI.GOV)
Cetiner, Mustafa Sacit; none,; Flanagan, George F.
2014-07-30
An integrated simulation platform that couples probabilistic analysis-based tools with model-based simulation tools can provide valuable insights for reactive and proactive responses to plant operating conditions. The objective of this work is to demonstrate the benefits of a partial implementation of the Small Modular Reactor (SMR) Probabilistic Risk Assessment (PRA) Detailed Framework Specification through the coupling of advanced PRA capabilities and accurate multi-physics plant models. Coupling a probabilistic model with a multi-physics model will aid in design, operations, and safety by providing a more accurate understanding of plant behavior. This represents the first attempt at actually integrating these two typesmore » of analyses for a control system used for operations, on a faster than real-time basis. This report documents the development of the basic communication capability to exchange data with the probabilistic model using Reliability Workbench (RWB) and the multi-physics model using Dymola. The communication pathways from injecting a fault (i.e., failing a component) to the probabilistic and multi-physics models were successfully completed. This first version was tested with prototypic models represented in both RWB and Modelica. First, a simple event tree/fault tree (ET/FT) model was created to develop the software code to implement the communication capabilities between the dynamic-link library (dll) and RWB. A program, written in C#, successfully communicates faults to the probabilistic model through the dll. A systems model of the Advanced Liquid-Metal Reactor–Power Reactor Inherently Safe Module (ALMR-PRISM) design developed under another DOE project was upgraded using Dymola to include proper interfaces to allow data exchange with the control application (ConApp). A program, written in C+, successfully communicates faults to the multi-physics model. The results of the example simulation were successfully plotted.« less
RAM simulation model for SPH/RSV systems
DOE Office of Scientific and Technical Information (OSTI.GOV)
Schryver, J.C.; Primm, A.H.; Nelson, S.C.
1995-12-31
The US Army`s Project Manager, Crusader is sponsoring the development of technologies that apply to the Self-Propelled Howitzer (SPH), formerly the Advanced Field Artillery System (AFAS), and Resupply Vehicle (RSV), formerly the Future Armored Resupply Vehicle (FARV), weapon system. Oak Ridge National Laboratory (ORNL) is currently performing developmental work in support of the SPH/PSV Crusader system. Supportive analyses of reliability, availability, and maintainability (RAM) aspects were also performed for the SPH/RSV effort. During FY 1994 and FY 1995 OPNL conducted a feasibility study to demonstrate the application of simulation modeling for RAM analysis of the Crusader system. Following completion ofmore » the feasibility study, a full-scale RAM simulation model of the Crusader system was developed for both the SPH and PSV. This report provides documentation for the simulation model as well as instructions in the proper execution and utilization of the model for the conduct of RAM analyses.« less
A comparison of cosmological hydrodynamic codes
NASA Technical Reports Server (NTRS)
Kang, Hyesung; Ostriker, Jeremiah P.; Cen, Renyue; Ryu, Dongsu; Hernquist, Lars; Evrard, August E.; Bryan, Greg L.; Norman, Michael L.
1994-01-01
We present a detailed comparison of the simulation results of various hydrodynamic codes. Starting with identical initial conditions based on the cold dark matter scenario for the growth of structure, with parameters h = 0.5 Omega = Omega(sub b) = 1, and sigma(sub 8) = 1, we integrate from redshift z = 20 to z = O to determine the physical state within a representative volume of size L(exp 3) where L = 64 h(exp -1) Mpc. Five indenpendent codes are compared: three of them Eulerian mesh-based and two variants of the smooth particle hydrodynamics 'SPH' Lagrangian approach. The Eulerian codes were run at N(exp 3) = (32(exp 3), 64(exp 3), 128(exp 3), and 256(exp 3)) cells, the SPH codes at N(exp 3) = 32(exp 3) and 64(exp 3) particles. Results were then rebinned to a 16(exp 3) grid with the exception that the rebinned data should converge, by all techniques, to a common and correct result as N approaches infinity. We find that global averages of various physical quantities do, as expected, tend to converge in the rebinned model, but that uncertainites in even primitive quantities such as (T), (rho(exp 2))(exp 1/2) persists at the 3%-17% level achieve comparable and satisfactory accuracy for comparable computer time in their treatment of the high-density, high-temeprature regions as measured in the rebinned data; the variance among the five codes (at highest resolution) for the mean temperature (as weighted by rho(exp 2) is only 4.5%. Examined at high resolution we suspect that the density resolution is better in the SPH codes and the thermal accuracy in low-density regions better in the Eulerian codes. In the low-density, low-temperature regions the SPH codes have poor accuracy due to statiscal effects, and the Jameson code gives the temperatures which are too high, due to overuse of artificial viscosity in these high Mach number regions. Overall the comparison allows us to better estimate errors; it points to ways of improving this current generation ofhydrodynamic
Comparing AMR and SPH Cosmological Simulations. I. Dark Matter and Adiabatic Simulations
NASA Astrophysics Data System (ADS)
O'Shea, Brian W.; Nagamine, Kentaro; Springel, Volker; Hernquist, Lars; Norman, Michael L.
2005-09-01
We compare two cosmological hydrodynamic simulation codes in the context of hierarchical galaxy formation: the Lagrangian smoothed particle hydrodynamics (SPH) code GADGET, and the Eulerian adaptive mesh refinement (AMR) code Enzo. Both codes represent dark matter with the N-body method but use different gravity solvers and fundamentally different approaches for baryonic hydrodynamics. The SPH method in GADGET uses a recently developed ``entropy conserving'' formulation of SPH, while for the mesh-based Enzo two different formulations of Eulerian hydrodynamics are employed: the piecewise parabolic method (PPM) extended with a dual energy formulation for cosmology, and the artificial viscosity-based scheme used in the magnetohydrodynamics code ZEUS. In this paper we focus on a comparison of cosmological simulations that follow either only dark matter, or also a nonradiative (``adiabatic'') hydrodynamic gaseous component. We perform multiple simulations using both codes with varying spatial and mass resolution with identical initial conditions. The dark matter-only runs agree generally quite well provided Enzo is run with a comparatively fine root grid and a low overdensity threshold for mesh refinement, otherwise the abundance of low-mass halos is suppressed. This can be readily understood as a consequence of the hierarchical particle-mesh algorithm used by Enzo to compute gravitational forces, which tends to deliver lower force resolution than the tree-algorithm of GADGET at early times before any adaptive mesh refinement takes place. At comparable force resolution we find that the latter offers substantially better performance and lower memory consumption than the present gravity solver in Enzo. In simulations that include adiabatic gasdynamics we find general agreement in the distribution functions of temperature, entropy, and density for gas of moderate to high overdensity, as found inside dark matter halos. However, there are also some significant differences in
A smooth particle hydrodynamics code to model collisions between solid, self-gravitating objects
NASA Astrophysics Data System (ADS)
Schäfer, C.; Riecker, S.; Maindl, T. I.; Speith, R.; Scherrer, S.; Kley, W.
2016-05-01
Context. Modern graphics processing units (GPUs) lead to a major increase in the performance of the computation of astrophysical simulations. Owing to the different nature of GPU architecture compared to traditional central processing units (CPUs) such as x86 architecture, existing numerical codes cannot be easily migrated to run on GPU. Here, we present a new implementation of the numerical method smooth particle hydrodynamics (SPH) using CUDA and the first astrophysical application of the new code: the collision between Ceres-sized objects. Aims: The new code allows for a tremendous increase in speed of astrophysical simulations with SPH and self-gravity at low costs for new hardware. Methods: We have implemented the SPH equations to model gas, liquids and elastic, and plastic solid bodies and added a fragmentation model for brittle materials. Self-gravity may be optionally included in the simulations and is treated by the use of a Barnes-Hut tree. Results: We find an impressive performance gain using NVIDIA consumer devices compared to our existing OpenMP code. The new code is freely available to the community upon request. If you are interested in our CUDA SPH code miluphCUDA, please write an email to Christoph Schäfer. miluphCUDA is the CUDA port of miluph. miluph is pronounced [maßl2v]. We do not support the use of the code for military purposes.
Water Flow Simulation using Smoothed Particle Hydrodynamics (SPH)
NASA Technical Reports Server (NTRS)
Vu, Bruce; Berg, Jared; Harris, Michael F.
2014-01-01
Simulation of water flow from the rainbird nozzles has been accomplished using the Smoothed Particle Hydrodynamics (SPH). The advantage of using SPH is that no meshing is required, thus the grid quality is no longer an issue and accuracy can be improved.
Kinetically controlled synthesis of Au102(SPh)44 nanoclusters and catalytic application
NASA Astrophysics Data System (ADS)
Chen, Yongdong; Wang, Jin; Liu, Chao; Li, Zhimin; Li, Gao
2016-05-01
We here explore a kinetically controlled synthetic protocol for preparing solvent-solvable Au102(SPh)44 nanoclusters which are isolated from polydispersed gold nanoclusters by solvent extraction and size exclusion chromatography (SEC). The as-obtained Au102(SPh)44 nanoclusters are determined by matrix-assisted laser desorption ionization (MALDI) and electrospray ionization (ESI) mass spectrometry, in conjunction with UV-vis spectroscopy and thermogravimetric analysis (TGA). However, Au99(SPh)42, instead of Au102(SPh)44, is yielded when the polydispersed gold nanoclusters are etched in the presence of excess thiophenol under thermal conditions (e.g., 80 °C). Interestingly, the Au102(SPh)44 nanoclusters also can convert to Au99(SPh)42 with equivalent thiophenol ligands, evidenced by the analyses of UV-vis and MALDI mass spectrometry. Finally, the TiO2-supported Au102(SPh)44 nanocluster catalyst is investigated in the selective oxidation of sulfides into sulfoxides by the PhIO oxidant and gives rise to high catalytic activity (e.g., 80-99% conversion of R-S-R' sulfides with 96-99% selectivity for R-S(&z.dbd;O)-R' sulfoxides). The Au102(SPh)44/TiO2 catalyst also shows excellent recyclability in the sulfoxidation process.We here explore a kinetically controlled synthetic protocol for preparing solvent-solvable Au102(SPh)44 nanoclusters which are isolated from polydispersed gold nanoclusters by solvent extraction and size exclusion chromatography (SEC). The as-obtained Au102(SPh)44 nanoclusters are determined by matrix-assisted laser desorption ionization (MALDI) and electrospray ionization (ESI) mass spectrometry, in conjunction with UV-vis spectroscopy and thermogravimetric analysis (TGA). However, Au99(SPh)42, instead of Au102(SPh)44, is yielded when the polydispersed gold nanoclusters are etched in the presence of excess thiophenol under thermal conditions (e.g., 80 °C). Interestingly, the Au102(SPh)44 nanoclusters also can convert to Au99(SPh)42 with equivalent
Characterization of a serine proteinase homologous (SPH) in Chinese mitten crab Eriocheir sinensis.
Qin, Chuanjie; Chen, Liqiao; Qin, Jian G; Zhao, Daxian; Zhang, Hao; Wu, Ping; Li, Erchao
2010-01-01
The serine protease homologous (SPH) is an important cofactor of prophenoloxidase-activating enzyme (PPAE). The gene of SPH of Chinese mitten crab Eriocheir sinensis (EsSPH) in hemocytes was cloned and characterized using reverse transcript polymerase chain reaction (RT-PCR) and rapid amplification of cDNA ends (RACE). The SPH cDNA consisted of 1386 bp with an open reading frame (ORF) encoded a protein of 378 amino acids, 154 bp 5'-untranslated region, and 95 bp 3'-untranslated region. Sequence comparisons against the GenBank database showed that EsSPH deduced amino acids had an overall identity to the gene of serine protease family from 41% to 70% of 15 invertebrate species. The protein had the structural characteristics of SPH, including the conserved six cysteine residues in the N-terminal clip domain and the functional activity (His157, Asp209, Gly311) in the C-terminal serine proteinase-like domain. To analyze the role of EsSPH in an acute infection, the temporal expression of the EsSPH gene after the Aeromonas hydrophila challenge was measured by real-time RT-PCR. The EsSPH transcripts in hemocytes significantly increased at 6 h, 12 h and 48 h over time after the A. hydrophila injection. This expression pattern shows that EsSPH has the potential to defend against invading microorganisms. The mRNA transcripts of EsSPH were detected in all tissues with the highest in the hepatopancreas. Interestingly, the mRNA transcripts of EsSPH and proPO were found in ova and expressed in oosperms, suggesting that the maternal transfer of EsSPH and proPO may exit in crab, but this warrants confirmation in further research.
Multiphysics Application Coupling Toolkit
DOE Office of Scientific and Technical Information (OSTI.GOV)
Campbell, Michael T.
2013-12-02
This particular consortium implementation of the software integration infrastructure will, in large part, refactor portions of the Rocstar multiphysics infrastructure. Development of this infrastructure originated at the University of Illinois DOE ASCI Center for Simulation of Advanced Rockets (CSAR) to support the center's massively parallel multiphysics simulation application, Rocstar, and has continued at IllinoisRocstar, a small company formed near the end of the University-based program. IllinoisRocstar is now licensing these new developments as free, open source, in hopes to help improve their own and others' access to infrastructure which can be readily utilized in developing coupled or composite software systems;more » with particular attention to more rapid production and utilization of multiphysics applications in the HPC environment. There are two major pieces to the consortium implementation, the Application Component Toolkit (ACT), and the Multiphysics Application Coupling Toolkit (MPACT). The current development focus is the ACT, which is (will be) the substrate for MPACT. The ACT itself is built up from the components described in the technical approach. In particular, the ACT has the following major components: 1.The Component Object Manager (COM): The COM package provides encapsulation of user applications, and their data. COM also provides the inter-component function call mechanism. 2.The System Integration Manager (SIM): The SIM package provides constructs and mechanisms for orchestrating composite systems of multiply integrated pieces.« less
Self-perception of health (SPH) in the oldest-old subjects.
Zikic, L; Jankelic, S; Milosevic, D P; Despotovic, N; Erceg, P; Davidovic, M
2009-01-01
SPH is a subjective and objective assessment of personal health. It is important in evaluation of health status in the elderly as it has capacity to predict mortality, functional declining, and health-care demands. A lot of research has been published about SPH in the elderly, but little is known about SPH in the very old, especially in comparison with the "younger-old" (YO) population. The study has aimed to investigate SPH in 240 elderly patients and compare the data between the "oldest-old" (OO) (aged >or= 90 years; n=52) and the YO (aged 60-74 years; n=188) subjects. Results have shown that the OO group of patients had better SPH than their YO counterparts. Our findings implicate that very old persons belong to a special sub-group of elderly, the "successfully aged", probably due to their genetic stability, distinctive lifestyle, or both.
SPH for impact force and ricochet behavior of water-entry bodies
NASA Astrophysics Data System (ADS)
Omidvar, Pourya; Farghadani, Omid; Nikeghbali, Pooyan
The numerical modeling of fluid interaction with a bouncing body has many applications in scientific and engineering application. In this paper, the problem of water impact of a body on free-surface is investigated, where the fixed ghost boundary condition is added to the open source code SPHysics2D1 to rectify the oscillations in pressure distributions with the repulsive boundary condition. First, after introducing the methodology of SPH and the option of boundary conditions, the still water problem is simulated using two types of boundary conditions. It is shown that the fixed ghost boundary condition gives a better result for a hydrostatics pressure. Then, the dam-break problem, which is a bench mark test case in SPH, is simulated and compared with available data. In order to show the behavior of the hydrostatics forces on bodies, a fix/floating cylinder is placed on free surface looking carefully at the force and heaving profile. Finally, the impact of a body on free-surface is successfully simulated for different impact angles and velocities.
Meshless Lagrangian SPH method applied to isothermal lid-driven cavity flow at low-Re numbers
NASA Astrophysics Data System (ADS)
Fraga Filho, C. A. D.; Chacaltana, J. T. A.; Pinto, W. J. N.
2018-01-01
SPH is a recent particle method applied in the cavities study, without many results available in the literature. The lid-driven cavity flow is a classic problem of the fluid mechanics, extensively explored in the literature and presenting a considerable complexity. The aim of this paper is to present a solution from the Lagrangian viewpoint for this problem. The discretization of the continuum domain is performed using the Lagrangian particles. The physical laws of mass, momentum and energy conservation are presented by the Navier-Stokes equations. A serial numerical code, written in Fortran programming language, has been used to perform the numerical simulations. The application of the SPH and comparison with the literature (mesh methods and a meshless collocation method) have been done. The positions of the primary vortex centre and the non-dimensional velocity profiles passing through the geometric centre of the cavity have been analysed. The numerical Lagrangian results showed a good agreement when compared to the results found in the literature, specifically for { Re} < 100.00 . Suggestions for improvements in the SPH model presented are listed, in the search for better results for flows with higher Reynolds numbers.
Au38(SPh)24: Au38 Protected with Aromatic Thiolate Ligands.
Rambukwella, Milan; Burrage, Shayna; Neubrander, Marie; Baseggio, Oscar; Aprà, Edoardo; Stener, Mauro; Fortunelli, Alessandro; Dass, Amala
2017-04-06
Au 38 (SR) 24 is one of the most extensively investigated gold nanomolecules along with Au 25 (SR) 18 and Au 144 (SR) 60 . However, so far it has only been prepared using aliphatic-like ligands, where R = -SC 6 H 13 , -SC 12 H 25 and -SCH 2 CH 2 Ph. Au 38 (SCH 2 CH 2 Ph) 24 when reacted with HSPh undergoes core-size conversion to Au 36 (SPh) 24 , and existing literature suggests that Au 38 (SPh) 24 cannot be synthesized. Here, contrary to prevailing knowledge, we demonstrate that Au 38 (SPh) 24 can be prepared if the ligand exchanged conditions are optimized, under delicate conditions, without any formation of Au 36 (SPh) 24 . Conclusive evidence is presented in the form of matrix-assisted laser desorption/ionization mass spectrometry (MALDI-MS), electrospray ionization mass spectra (ESI-MS) characterization, and optical spectra of Au 38 (SPh) 24 in a solid glass form showing distinct differences from that of Au 38 (S-aliphatic) 24 . Theoretical analysis confirms experimental assignment of the optical spectrum and shows that the stability of Au 38 (SPh) 24 is not negligible with respect to that of its aliphatic analogous, and contains a significant component of ligand-ligand attractive interactions. Thus, while Au 38 (SPh) 24 is stable at RT, it converts to Au 36 (SPh) 24 either on prolonged etching (longer than 2 hours) at RT or when etched at 80 °C.
NASA Technical Reports Server (NTRS)
Perrell, Eric R.
2005-01-01
level-two design tools for PARSEC. The "CFD Multiphysics Tool" will be the propulsive element of the tool set. The name acknowledges that space propulsion performance assessment is primarily a fluid mechanics problem. At the core of the CFD Multiphysics Tool is an open-source CFD code, HYP, under development at ERAU. ERAU is renowned for its undergraduate degree program in Aerospace Engineering the largest in the nation. The strength of the program is its applications-oriented curriculum, which culminates in one of three two-course Engineering Design sequences: Aerospace Propulsion, Spacecraft, or Aircraft. This same philosophy applies to the HYP Project, albeit with fluid physics modeling commensurate with graduate research. HYP s purpose, like the Multiphysics Tool s, is to enable calculations of real (three-dimensional; geometrically complex; intended for hardware development) applications of high speed and propulsive fluid flows.
Kinetically controlled synthesis of Au102(SPh)44 nanoclusters and catalytic application.
Chen, Yongdong; Wang, Jin; Liu, Chao; Li, Zhimin; Li, Gao
2016-05-21
We here explore a kinetically controlled synthetic protocol for preparing solvent-solvable Au102(SPh)44 nanoclusters which are isolated from polydispersed gold nanoclusters by solvent extraction and size exclusion chromatography (SEC). The as-obtained Au102(SPh)44 nanoclusters are determined by matrix-assisted laser desorption ionization (MALDI) and electrospray ionization (ESI) mass spectrometry, in conjunction with UV-vis spectroscopy and thermogravimetric analysis (TGA). However, Au99(SPh)42, instead of Au102(SPh)44, is yielded when the polydispersed gold nanoclusters are etched in the presence of excess thiophenol under thermal conditions (e.g., 80 °C). Interestingly, the Au102(SPh)44 nanoclusters also can convert to Au99(SPh)42 with equivalent thiophenol ligands, evidenced by the analyses of UV-vis and MALDI mass spectrometry. Finally, the TiO2-supported Au102(SPh)44 nanocluster catalyst is investigated in the selective oxidation of sulfides into sulfoxides by the PhIO oxidant and gives rise to high catalytic activity (e.g., 80-99% conversion of R-S-R' sulfides with 96-99% selectivity for R-S([double bond, length as m-dash]O)-R' sulfoxides). The Au102(SPh)44/TiO2 catalyst also shows excellent recyclability in the sulfoxidation process.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Procassini, R.J.
1997-12-31
The fine-scale, multi-space resolution that is envisioned for accurate simulations of complex weapons systems in three spatial dimensions implies flop-rate and memory-storage requirements that will only be obtained in the near future through the use of parallel computational techniques. Since the Monte Carlo transport models in these simulations usually stress both of these computational resources, they are prime candidates for parallelization. The MONACO Monte Carlo transport package, which is currently under development at LLNL, will utilize two types of parallelism within the context of a multi-physics design code: decomposition of the spatial domain across processors (spatial parallelism) and distribution ofmore » particles in a given spatial subdomain across additional processors (particle parallelism). This implementation of the package will utilize explicit data communication between domains (message passing). Such a parallel implementation of a Monte Carlo transport model will result in non-deterministic communication patterns. The communication of particles between subdomains during a Monte Carlo time step may require a significant level of effort to achieve a high parallel efficiency.« less
Characterizing flow in oil reservoir rock using SPH: absolute permeability
NASA Astrophysics Data System (ADS)
Holmes, David W.; Williams, John R.; Tilke, Peter; Leonardi, Christopher R.
2016-04-01
In this paper, a three-dimensional smooth particle hydrodynamics (SPH) simulator for modeling grain scale fluid flow in porous rock is presented. The versatility of the SPH method has driven its use in increasingly complex areas of flow analysis, including flows related to permeable rock for both groundwater and petroleum reservoir research. While previous approaches to such problems using SPH have involved the use of idealized pore geometries (cylinder/sphere packs etc), in this paper we detail the characterization of flow in models with geometries taken from 3D X-ray microtomographic imaging of actual porous rock; specifically 25.12 % porosity dolomite. This particular rock type has been well characterized experimentally and described in the literature, thus providing a practical `real world' means of verification of SPH that will be key to its acceptance by industry as a viable alternative to traditional reservoir modeling tools. The true advantages of SPH are realized when adding the complexity of multiple fluid phases, however, the accuracy of SPH for single phase flow is, as yet, under developed in the literature and will be the primary focus of this paper. Flow in reservoir rock will typically occur in the range of low Reynolds numbers, making the enforcement of no-slip boundary conditions an important factor in simulation. To this end, we detail the development of a new, robust, and numerically efficient method for implementing no-slip boundary conditions in SPH that can handle the degree of complexity of boundary surfaces, characteristic of an actual permeable rock sample. A study of the effect of particle density is carried out and simulation results for absolute permeability are presented and compared to those from experimentation showing good agreement and validating the method for such applications.
RR Lyrae in the UMi dSph Galaxy
NASA Astrophysics Data System (ADS)
Kuehn, Charles; Kinemuchi, Karen; Jeffery, Elizabeth; Grabowski, Kathleen; Nemec, James; Herrera, Daniel
2018-01-01
Over the past two years we have obtained observations of the Ursa Minor dwarf spheroidal galaxy with the goal of completing an updated catalog of the variable stars in the dwarf galaxy. In addition to finding new variable stars, this updated catalog will allow us to look at period changes in the variables and to determine stellar characteristic for the RR Lyrae stars in the dSph. We will compare the RR Lyrae stellar characteristics to other RR Lyrae stars found in the Local Group dSph galaxies; these comparisons can give us insights to the near-field cosmology of the Local Group. In this poster we present our updated catalog of RR Lyrae stars in the UMi dSph; the updated catalog includes Fourier decomposition parameters, metallicities, and other physical properties for the RR Lyrae stars.
A Multiphysics and Multiscale Software Environment for Modeling Astrophysical Systems
NASA Astrophysics Data System (ADS)
Portegies Zwart, Simon; McMillan, Steve; O'Nualláin, Breanndán; Heggie, Douglas; Lombardi, James; Hut, Piet; Banerjee, Sambaran; Belkus, Houria; Fragos, Tassos; Fregeau, John; Fuji, Michiko; Gaburov, Evghenii; Glebbeek, Evert; Groen, Derek; Harfst, Stefan; Izzard, Rob; Jurić, Mario; Justham, Stephen; Teuben, Peter; van Bever, Joris; Yaron, Ofer; Zemp, Marcel
We present MUSE, a software framework for tying together existing computational tools for different astrophysical domains into a single multiphysics, multiscale workload. MUSE facilitates the coupling of existing codes written in different languages by providing inter-language tools and by specifying an interface between each module and the framework that represents a balance between generality and computational efficiency. This approach allows scientists to use combinations of codes to solve highly-coupled problems without the need to write new codes for other domains or significantly alter their existing codes. MUSE currently incorporates the domains of stellar dynamics, stellar evolution and stellar hydrodynamics for a generalized stellar systems workload. MUSE has now reached a "Noah's Ark" milestone, with two available numerical solvers for each domain. MUSE can treat small stellar associations, galaxies and everything in between, including planetary systems, dense stellar clusters and galactic nuclei. Here we demonstrate an examples calculated with MUSE: the merger of two galaxies. In addition we demonstrate the working of MUSE on a distributed computer. The current MUSE code base is publicly available as open source at http://muse.li.
A density-adaptive SPH method with kernel gradient correction for modeling explosive welding
NASA Astrophysics Data System (ADS)
Liu, M. B.; Zhang, Z. L.; Feng, D. L.
2017-09-01
Explosive welding involves processes like the detonation of explosive, impact of metal structures and strong fluid-structure interaction, while the whole process of explosive welding has not been well modeled before. In this paper, a novel smoothed particle hydrodynamics (SPH) model is developed to simulate explosive welding. In the SPH model, a kernel gradient correction algorithm is used to achieve better computational accuracy. A density adapting technique which can effectively treat large density ratio is also proposed. The developed SPH model is firstly validated by simulating a benchmark problem of one-dimensional TNT detonation and an impact welding problem. The SPH model is then successfully applied to simulate the whole process of explosive welding. It is demonstrated that the presented SPH method can capture typical physics in explosive welding including explosion wave, welding surface morphology, jet flow and acceleration of the flyer plate. The welding angle obtained from the SPH simulation agrees well with that from a kinematic analysis.
NASA Astrophysics Data System (ADS)
El-Wardany, Tahany; Lynch, Mathew; Gu, Wenjiong; Hsu, Arthur; Klecka, Michael; Nardi, Aaron; Viens, Daniel
This paper proposes an optimization framework enabling the integration of multi-scale / multi-physics simulation codes to perform structural optimization design for additively manufactured components. Cold spray was selected as the additive manufacturing (AM) process and its constraints were identified and included in the optimization scheme. The developed framework first utilizes topology optimization to maximize stiffness for conceptual design. The subsequent step applies shape optimization to refine the design for stress-life fatigue. The component weight was reduced by 20% while stresses were reduced by 75% and the rigidity was improved by 37%. The framework and analysis codes were implemented using Altair software as well as an in-house loading code. The optimized design was subsequently produced by the cold spray process.
Optimization of coupled multiphysics methodology for safety analysis of pebble bed modular reactor
NASA Astrophysics Data System (ADS)
Mkhabela, Peter Tshepo
The research conducted within the framework of this PhD thesis is devoted to the high-fidelity multi-physics (based on neutronics/thermal-hydraulics coupling) analysis of Pebble Bed Modular Reactor (PBMR), which is a High Temperature Reactor (HTR). The Next Generation Nuclear Plant (NGNP) will be a HTR design. The core design and safety analysis methods are considerably less developed and mature for HTR analysis than those currently used for Light Water Reactors (LWRs). Compared to LWRs, the HTR transient analysis is more demanding since it requires proper treatment of both slower and much longer transients (of time scale in hours and days) and fast and short transients (of time scale in minutes and seconds). There is limited operation and experimental data available for HTRs for validation of coupled multi-physics methodologies. This PhD work developed and verified reliable high fidelity coupled multi-physics models subsequently implemented in robust, efficient, and accurate computational tools to analyse the neutronics and thermal-hydraulic behaviour for design optimization and safety evaluation of PBMR concept The study provided a contribution to a greater accuracy of neutronics calculations by including the feedback from thermal hydraulics driven temperature calculation and various multi-physics effects that can influence it. Consideration of the feedback due to the influence of leakage was taken into account by development and implementation of improved buckling feedback models. Modifications were made in the calculation procedure to ensure that the xenon depletion models were accurate for proper interpolation from cross section tables. To achieve this, the NEM/THERMIX coupled code system was developed to create the system that is efficient and stable over the duration of transient calculations that last over several tens of hours. Another achievement of the PhD thesis was development and demonstration of full-physics, three-dimensional safety analysis
Advanced graphical user interface for multi-physics simulations using AMST
NASA Astrophysics Data System (ADS)
Hoffmann, Florian; Vogel, Frank
2017-07-01
Numerical modelling of particulate matter has gained much popularity in recent decades. Advanced Multi-physics Simulation Technology (AMST) is a state-of-the-art three dimensional numerical modelling technique combining the eX-tended Discrete Element Method (XDEM) with Computational Fluid Dynamics (CFD) and Finite Element Analysis (FEA) [1]. One major limitation of this code is the lack of a graphical user interface (GUI) meaning that all pre-processing has to be made directly in a HDF5-file. This contribution presents the first graphical pre-processor developed for AMST.
A challenge to dSph formation models: are the most isolated Local Group dSph galaxies truly old?
NASA Astrophysics Data System (ADS)
Monelli, Matteo
2017-08-01
What is the origin of the different dwarf galaxy types? The classification into dwarf irregular (dIrr), spheroidal (dSph), and transition (dT) types is based on their present-day properties. However, star formation histories (SFHs) reconstructed from deep color-magnitude diagrams (CMDs) provide details on the early evolution of galaxies of all these types, and indicate only two basic evolutionary paths. One is characterized by a vigorous but brief initial star-forming event, and little or no star formation thereafter (fast evolution), and the other one by roughly continuous star formation until (nearly) the present time (slow evolution). These two paths do not map directly onto the dIrr, dT and dSph types. Thus, the present galaxy properties do not reflect their lifetime evolution. Since there are some indications that slow dwarfs were assembled in lower-density environments than fast dwarfs, Gallart et al (2015) proposed that the distinction between fast and slow dwarfs reflects the characteristic density of the environment where they formed. This scenario, and more generally scenarios where dSph galaxies formed through the interaction with a massive galaxy, are challenged by a small sample of extremely isolated dSph/dT in the outer fringes of the Local Group. This proposal targets two of these objects (VV124, KKR25) for which we will infer their SFH - through a novel technique that combines the information from their RR Lyrae stars and deep CMDs sampling the intermediate-age population - in order to test these scenarios. This is much less demanding on observing time than classical SFH derivation using full depth CMDs.
Kharel, Yugesh; Raje, Mithun R.; Gao, Ming; Tomsig, Jose L.; Lynch, Kevin R.; Santos, Webster L.
2015-01-01
Sphingosine 1-phosphate (S1P) is a pleiotropic signaling molecule that acts as a ligand for five G-protein coupled receptors (S1P1–5) whose downstream effects are implicated in a variety of important pathologies including sickle cell disease, cancer, inflammation, and fibrosis. The synthesis of S1P is catalyzed by sphingosine kinase (SphK) isoforms 1 and 2, and hence, inhibitors of this phosphorylation step are pivotal in understanding the physiological functions of SphKs. To date, SphK1 and 2 inhibitors with the potency, selectivity, and in vivo stability necessary to determine the potential of these kinases as therapeutic targets are lacking. Herein, we report the design, synthesis, and structure–activity relationship studies of guanidine-based SphK inhibitors bearing an oxadiazole ring in the scaffold. Our studies demonstrate that SLP120701, a SphK2-selective inhibitor (Ki = 1 μM), decreases S1P levels in histiocytic lymphoma (U937) cells. Surprisingly, homologation with a single methylene unit between the oxadiazole and heterocyclic ring afforded a SphK1-selective inhibitor in SLP7111228 (Ki = 48 nM), which also decreased S1P levels in cultured U937 cells. In vivo application of both compounds, however, resulted in contrasting effect in circulating levels of S1P. Administration of SLP7111228 depressed blood S1P levels while SLP120701 increased levels of S1P. Taken together, these compounds provide an in vivo chemical toolkit to interrogate the effect of increasing or decreasing S1P levels and whether such a maneuver can have implications in disease states. PMID:25643074
Developing Discontinuous Galerkin Methods for Solving Multiphysics Problems in General Relativity
NASA Astrophysics Data System (ADS)
Kidder, Lawrence; Field, Scott; Teukolsky, Saul; Foucart, Francois; SXS Collaboration
2016-03-01
Multi-messenger observations of the merger of black hole-neutron star and neutron star-neutron star binaries, and of supernova explosions will probe fundamental physics inaccessible to terrestrial experiments. Modeling these systems requires a relativistic treatment of hydrodynamics, including magnetic fields, as well as neutrino transport and nuclear reactions. The accuracy, efficiency, and robustness of current codes that treat all of these problems is not sufficient to keep up with the observational needs. We are building a new numerical code that uses the Discontinuous Galerkin method with a task-based parallelization strategy, a promising combination that will allow multiphysics applications to be treated both accurately and efficiently on petascale and exascale machines. The code will scale to more than 100,000 cores for efficient exploration of the parameter space of potential sources and allowed physics, and the high-fidelity predictions needed to realize the promise of multi-messenger astronomy. I will discuss the current status of the development of this new code.
The Role of Multiphysics Simulation in Multidisciplinary Analysis
NASA Technical Reports Server (NTRS)
Rifai, Steven M.; Ferencz, Robert M.; Wang, Wen-Ping; Spyropoulos, Evangelos T.; Lawrence, Charles; Melis, Matthew E.
1998-01-01
This article describes the applications of the Spectrum(Tm) Solver in Multidisciplinary Analysis (MDA). Spectrum, a multiphysics simulation software based on the finite element method, addresses compressible and incompressible fluid flow, structural, and thermal modeling as well as the interaction between these disciplines. Multiphysics simulation is based on a single computational framework for the modeling of multiple interacting physical phenomena. Interaction constraints are enforced in a fully-coupled manner using the augmented-Lagrangian method. Within the multiphysics framework, the finite element treatment of fluids is based on Galerkin-Least-Squares (GLS) method with discontinuity capturing operators. The arbitrary-Lagrangian-Eulerian method is utilized to account for deformable fluid domains. The finite element treatment of solids and structures is based on the Hu-Washizu variational principle. The multiphysics architecture lends itself naturally to high-performance parallel computing. Aeroelastic, propulsion, thermal management and manufacturing applications are presented.
Pairwise Force SPH Model for Real-Time Multi-Interaction Applications.
Yang, Tao; Martin, Ralph R; Lin, Ming C; Chang, Jian; Hu, Shi-Min
2017-10-01
In this paper, we present a novel pairwise-force smoothed particle hydrodynamics (PF-SPH) model to enable simulation of various interactions at interfaces in real time. Realistic capture of interactions at interfaces is a challenging problem for SPH-based simulations, especially for scenarios involving multiple interactions at different interfaces. Our PF-SPH model can readily handle multiple types of interactions simultaneously in a single simulation; its basis is to use a larger support radius than that used in standard SPH. We adopt a novel anisotropic filtering term to further improve the performance of interaction forces. The proposed model is stable; furthermore, it avoids the particle clustering problem which commonly occurs at the free surface. We show how our model can be used to capture various interactions. We also consider the close connection between droplets and bubbles, and show how to animate bubbles rising in liquid as well as bubbles in air. Our method is versatile, physically plausible and easy-to-implement. Examples are provided to demonstrate the capabilities and effectiveness of our approach.
A novel SPH method for sedimentation in a turbulent fluid
DOE Office of Scientific and Technical Information (OSTI.GOV)
Kwon, Jihoe; Monaghan, J.J., E-mail: joe.monaghan@sci.monash.edu.au
2015-11-01
A novel method for simulating sedimentation is described and applied to the sedimentation of dust in a turbulent fluid. We assume the dust grains are sufficiently numerous that they may be treated as a fluid and modelled by SPH particles. A different set of SPH particles describes the fluid. The equations of motion are therefore similar to those of Monaghan and Kocharyan [14] with the exception that the sedimentation of dust onto a solid surface is treated as if the surface mimics a sink for the dust fluid. The continuity equation for the dust then contains a sink term thatmore » can be modelled in the SPH formulation by allowing the mass of each SPH dust particle to decrease when it is sufficiently close to the boundary. We apply this method both to sedimentation in a nearly static fluid, and to sedimentation in a turbulent fluid. In the latter case we produce the turbulence by both a mechanical stirrer and by a stochastic algorithm. Our results agree very closely with the experiments of Martin and Nokes.« less
SPH Modelling of Sea-ice Pack Dynamics
NASA Astrophysics Data System (ADS)
Staroszczyk, Ryszard
2017-12-01
The paper is concerned with the problem of sea-ice pack motion and deformation under the action of wind and water currents. Differential equations describing the dynamics of ice, with its very distinct mateFfigrial responses in converging and diverging flows, express the mass and linear momentum balances on the horizontal plane (the free surface of the ocean). These equations are solved by the fully Lagrangian method of smoothed particle hydrodynamics (SPH). Assuming that the ice behaviour can be approximated by a non-linearly viscous rheology, the proposed SPH model has been used to simulate the evolution of a sea-ice pack driven by wind drag stresses. The results of numerical simulations illustrate the evolution of an ice pack, including variations in ice thickness and ice area fraction in space and time. The effects of different initial ice pack configurations and of different conditions assumed at the coast-ice interface are examined. In particular, the SPH model is applied to a pack flow driven by a vortex wind to demonstrate how well the Lagrangian formulation can capture large deformations and displacements of sea ice.
Comparison of ALE and SPH Methods for Simulating Mine Blast Effects on Structures
2010-12-01
Comparison of ALE and SPH methods for simulating mine blast effects on struc- tures Geneviève Toussaint Amal Bouamoul DRDC Valcartier Defence R&D...Canada – Valcartier Technical Report DRDC Valcartier TR 2010-326 December 2010 Comparison of ALE and SPH methods for simulating mine blast...Valcartier TR 2010-326 iii Executive summary Comparison of ALE and SPH methods for simulating mine blast effects on structures
NASA Astrophysics Data System (ADS)
Yamamoto, H.; Nakajima, K.; Zhang, K.; Nanai, S.
2015-12-01
Powerful numerical codes that are capable of modeling complex coupled processes of physics and chemistry have been developed for predicting the fate of CO2 in reservoirs as well as its potential impacts on groundwater and subsurface environments. However, they are often computationally demanding for solving highly non-linear models in sufficient spatial and temporal resolutions. Geological heterogeneity and uncertainties further increase the challenges in modeling works. Two-phase flow simulations in heterogeneous media usually require much longer computational time than that in homogeneous media. Uncertainties in reservoir properties may necessitate stochastic simulations with multiple realizations. Recently, massively parallel supercomputers with more than thousands of processors become available in scientific and engineering communities. Such supercomputers may attract attentions from geoscientist and reservoir engineers for solving the large and non-linear models in higher resolutions within a reasonable time. However, for making it a useful tool, it is essential to tackle several practical obstacles to utilize large number of processors effectively for general-purpose reservoir simulators. We have implemented massively-parallel versions of two TOUGH2 family codes (a multi-phase flow simulator TOUGH2 and a chemically reactive transport simulator TOUGHREACT) on two different types (vector- and scalar-type) of supercomputers with a thousand to tens of thousands of processors. After completing implementation and extensive tune-up on the supercomputers, the computational performance was measured for three simulations with multi-million grid models, including a simulation of the dissolution-diffusion-convection process that requires high spatial and temporal resolutions to simulate the growth of small convective fingers of CO2-dissolved water to larger ones in a reservoir scale. The performance measurement confirmed that the both simulators exhibit excellent
electromagnetics, eddy current, computer codes
DOE Office of Scientific and Technical Information (OSTI.GOV)
Gartling, David
TORO Version 4 is designed for finite element analysis of steady, transient and time-harmonic, multi-dimensional, quasi-static problems in electromagnetics. The code allows simulation of electrostatic fields, steady current flows, magnetostatics and eddy current problems in plane or axisymmetric, two-dimensional geometries. TORO is easily coupled to heat conduction and solid mechanics codes to allow multi-physics simulations to be performed.
Narayanavari, Suneel A; Lourdault, Kristel; Sritharan, Manjula; Haake, David A; Matsunaga, James
2015-01-01
Pathogenic members of the genus Leptospira are the causative agents of leptospirosis, a neglected disease of public and veterinary health concern. Leptospirosis is a systemic disease that in its severest forms leads to renal insufficiency, hepatic dysfunction, and pulmonary failure. Many strains of Leptospira produce hemolytic and sphingomyelinase activities, and a number of candidate leptospiral hemolysins have been identified based on sequence similarity to well-characterized bacterial hemolysins. Five of the putative hemolysins are sphingomyelinase paralogs. Although recombinant forms of the sphingomyelinase Sph2 and other hemolysins lyse erythrocytes, none have been demonstrated to contribute to the hemolytic activity secreted by leptospiral cells. In this study, we examined the regulation of sph2 and its relationship to hemolytic and sphingomyelinase activities produced by several L. interrogans strains cultivated under the osmotic conditions found in the mammalian host. The sph2 gene was poorly expressed when the Fiocruz L1-130 (serovar Copenhageni), 56601 (sv. Lai), and L495 (sv. Manilae) strains were cultivated in the standard culture medium EMJH. Raising EMJH osmolarity to physiological levels with sodium chloride enhanced Sph2 production in all three strains. In addition, the Pomona subtype kennewicki strain LC82-25 produced substantially greater amounts of Sph2 during standard EMJH growth than the other strains, and sph2 expression increased further by addition of salt. When 10% rat serum was present in EMJH along with the sodium chloride supplement, Sph2 production increased further in all strains. Osmotic regulation and differences in basal Sph2 production in the Manilae L495 and Pomona strains correlated with the levels of secreted hemolysin and sphingomyelinase activities. Finally, a transposon insertion in sph2 dramatically reduced hemolytic and sphingomyelinase activities during incubation of L. interrogans at physiologic osmolarity
Nimmala, Praneeth Reddy; Dass, Amala
2011-06-22
A new core size protected completely by an aromatic thiol, Au(36)(SPh)(23), is synthesized and characterized by MALDI-TOF mass spectrometry and UV-visible spectroscopy. The synthesis involving core size changes is studied by MS, and the complete ligand coverage by aromatic thiol group is shown by NMR.
NASA Astrophysics Data System (ADS)
Ševeček, P.; Brož, M.; Nesvorný, D.; Enke, B.; Durda, D.; Walsh, K.; Richardson, D. C.
2017-11-01
We report on our study of asteroidal breakups, i.e. fragmentations of targets, subsequent gravitational reaccumulation and formation of small asteroid families. We focused on parent bodies with diameters Dpb = 10km . Simulations were performed with a smoothed-particle hydrodynamics (SPH) code combined with an efficient N-body integrator. We assumed various projectile sizes, impact velocities and impact angles (125 runs in total). Resulting size-frequency distributions are significantly different from scaled-down simulations with Dpb = 100km targets (Durda et al., 2007). We derive new parametric relations describing fragment distributions, suitable for Monte-Carlo collisional models. We also characterize velocity fields and angular distributions of fragments, which can be used as initial conditions for N-body simulations of small asteroid families. Finally, we discuss a number of uncertainties related to SPH simulations.
Coupled SPH-FV method with net vorticity and mass transfer
NASA Astrophysics Data System (ADS)
Chiron, L.; Marrone, S.; Di Mascio, A.; Le Touzé, D.
2018-07-01
Recently, an algorithm for coupling a Finite Volume (FV) method, that discretize the Navier-Stokes equations on block structured Eulerian grids, with the weakly-compressible Lagrangian Smoothed Particle Hydrodynamics (SPH) was presented in [16]. The algorithm takes advantage of the SPH method to discretize flow regions close to free-surfaces and of the FV method to resolve the bulk flow and the wall regions. The continuity between the two solutions is guaranteed by overlapping zones. Here we extend the algorithm by adding the possibility to have: 1) net mass transfer between the SPH and FV sub-domains; 2) free-surface across the overlapping region. In this context, particle generation at common boundaries is required to prevent depletion or clustering of particles. This operation is not trivial, because consistency between the Lagrangian and Eulerian description of the flow must be retained to ensure mass conservation. We propose here a new coupling paradigm that extends the algorithm developed in [16] and renders it suitable to test cases where vorticity and free surface significantly pass from one domain to the other. On the SPH side, a novel technique for the creation/deletion of particle was developed. On the FV side, the information recovered from the SPH solver are exploited to improve free surface prediction in a fashion that resemble the Particle Level-Set algorithms. The combination of the two new features was tested and validated in a number of test cases where both vorticity and front evolution are important. Convergence and robustness of the algorithm are shown.
SWIFT: SPH With Inter-dependent Fine-grained Tasking
NASA Astrophysics Data System (ADS)
Schaller, Matthieu; Gonnet, Pedro; Chalk, Aidan B. G.; Draper, Peter W.
2018-05-01
SWIFT runs cosmological simulations on peta-scale machines for solving gravity and SPH. It uses the Fast Multipole Method (FMM) to calculate gravitational forces between nearby particles, combining these with long-range forces provided by a mesh that captures both the periodic nature of the calculation and the expansion of the simulated universe. SWIFT currently uses a single fixed but time-variable softening length for all the particles. Many useful external potentials are also available, such as galaxy haloes or stratified boxes that are used in idealised problems. SWIFT implements a standard LCDM cosmology background expansion and solves the equations in a comoving frame; equations of state of dark-energy evolve with scale-factor. The structure of the code allows implementation for modified-gravity solvers or self-interacting dark matter schemes to be implemented. Many hydrodynamics schemes are implemented in SWIFT and the software allows users to add their own.
X-Ray modeling of η Carinae & WR 140 from SPH simulations
NASA Astrophysics Data System (ADS)
Russell, Christopher M. P.; Corcoran, Michael F.; Okazaki, Atsuo T.; Madura, Thomas I.; Owocki, Stanley P.
2011-07-01
The colliding wind binary (CWB) systems η Carinae and WR140 provide unique laboratories for X-ray astrophysics. Their wind-wind collisions produce hard X-rays that have been monitored extensively by several X-ray telescopes, including RXTE. To interpret these RXTE X-ray light curves, we apply 3D hydrodynamic simulations of the wind-wind collision using smoothed particle hydrodynamics (SPH). We find adiabatic simulations that account for the absorption of X-rays from an assumed point source of X-ray emission at the apex of the wind-collision shock cone can closely match the RXTE light curves of both η Car and WR140. This point-source model can also explain the early recovery of η Car's X-ray light curve from the 2009.0 minimum by a factor of 2-4 reduction in the mass loss rate of η Car. Our more recent models account for the extended emission and absorption along the full wind-wind interaction shock front. For WR140, the computed X-ray light curves again match the RXTE observations quite well. But for η Car, a hot, post-periastron bubble leads to an emission level that does not match the extended X-ray minimum observed by RXTE. Initial results from incorporating radiative cooling and radiative forces via an anti-gravity approach into the SPH code are also discussed.
The Integrated Plasma Simulator: A Flexible Python Framework for Coupled Multiphysics Simulation
DOE Office of Scientific and Technical Information (OSTI.GOV)
Foley, Samantha S; Elwasif, Wael R; Bernholdt, David E
2011-11-01
High-fidelity coupled multiphysics simulations are an increasingly important aspect of computational science. In many domains, however, there has been very limited experience with simulations of this sort, therefore research in coupled multiphysics often requires computational frameworks with significant flexibility to respond to the changing directions of the physics and mathematics. This paper presents the Integrated Plasma Simulator (IPS), a framework designed for loosely coupled simulations of fusion plasmas. The IPS provides users with a simple component architecture into which a wide range of existing plasma physics codes can be inserted as components. Simulations can take advantage of multiple levels ofmore » parallelism supported in the IPS, and can be controlled by a high-level ``driver'' component, or by other coordination mechanisms, such as an asynchronous event service. We describe the requirements and design of the framework, and how they were implemented in the Python language. We also illustrate the flexibility of the framework by providing examples of different types of simulations that utilize various features of the IPS.« less
GIZMO: Multi-method magneto-hydrodynamics+gravity code
NASA Astrophysics Data System (ADS)
Hopkins, Philip F.
2014-10-01
GIZMO is a flexible, multi-method magneto-hydrodynamics+gravity code that solves the hydrodynamic equations using a variety of different methods. It introduces new Lagrangian Godunov-type methods that allow solving the fluid equations with a moving particle distribution that is automatically adaptive in resolution and avoids the advection errors, angular momentum conservation errors, and excessive diffusion problems that seriously limit the applicability of “adaptive mesh” (AMR) codes, while simultaneously avoiding the low-order errors inherent to simpler methods like smoothed-particle hydrodynamics (SPH). GIZMO also allows the use of SPH either in “traditional” form or “modern” (more accurate) forms, or use of a mesh. Self-gravity is solved quickly with a BH-Tree (optionally a hybrid PM-Tree for periodic boundaries) and on-the-fly adaptive gravitational softenings. The code is descended from P-GADGET, itself descended from GADGET-2 (ascl:0003.001), and many of the naming conventions remain (for the sake of compatibility with the large library of GADGET work and analysis software).
Raskin, Cody; Owen, J. Michael
2016-10-24
Here, we discuss a generalization of the classic Keplerian disk test problem allowing for both pressure and rotational support, as a method of testing astrophysical codes incorporating both gravitation and hydrodynamics. We argue for the inclusion of pressure in rotating disk simulations on the grounds that realistic, astrophysical disks exhibit non-negligible pressure support. We then apply this test problem to examine the performance of various smoothed particle hydrodynamics (SPH) methods incorporating a number of improvements proposed over the years to address problems noted in modeling the classical gravitation-only Keplerian disk. We also apply this test to a newly developed extensionmore » of SPH based on reproducing kernels called CRKSPH. Counterintuitively, we find that pressure support worsens the performance of traditional SPH on this problem, causing unphysical collapse away from the steady-state disk solution even more rapidly than the purely gravitational problem, whereas CRKSPH greatly reduces this error.« less
Multiscale and Multiphysics Modeling of Additive Manufacturing of Advanced Materials
NASA Technical Reports Server (NTRS)
Liou, Frank; Newkirk, Joseph; Fan, Zhiqiang; Sparks, Todd; Chen, Xueyang; Fletcher, Kenneth; Zhang, Jingwei; Zhang, Yunlu; Kumar, Kannan Suresh; Karnati, Sreekar
2015-01-01
, after investigating various methods, a Smoothed Particle Hydrodynamics Model (SPH Model) was developed to model wire feeding process. Its computational efficiency and simple architecture makes it more robust and flexible than other models. More research on material properties may be needed to realistically model the AAM processes. A microscale model was developed to investigate heterogeneous nucleation, dendritic grain growth, epitaxial growth of columnar grains, columnar-to-equiaxed transition, grain transport in melt, and other properties. The orientations of the columnar grains were almost perpendicular to the laser motion's direction. Compared to the similar studies in the literature, the multiple grain morphology modeling result is in the same order of magnitude as optical morphologies in the experiment. Experimental work was conducted to validate different models. An infrared camera was incorporated as a process monitoring and validating tool to identify the solidus and mushy zones during deposition. The images were successfully processed to identify these regions. This research project has investigated multiscale and multiphysics of the complex AAM processes thus leading to advanced understanding of these processes. The project has also developed several modeling tools and experimental validation tools that will be very critical in the future of AAM process qualification and certification.
Two-way coupled SPH and particle level set fluid simulation.
Losasso, Frank; Talton, Jerry; Kwatra, Nipun; Fedkiw, Ronald
2008-01-01
Grid-based methods have difficulty resolving features on or below the scale of the underlying grid. Although adaptive methods (e.g. RLE, octrees) can alleviate this to some degree, separate techniques are still required for simulating small-scale phenomena such as spray and foam, especially since these more diffuse materials typically behave quite differently than their denser counterparts. In this paper, we propose a two-way coupled simulation framework that uses the particle level set method to efficiently model dense liquid volumes and a smoothed particle hydrodynamics (SPH) method to simulate diffuse regions such as sprays. Our novel SPH method allows us to simulate both dense and diffuse water volumes, fully incorporates the particles that are automatically generated by the particle level set method in under-resolved regions, and allows for two way mixing between dense SPH volumes and grid-based liquid representations.
SPH modeling of the Stickney impact at Phobos
NASA Astrophysics Data System (ADS)
Bruck Syal, Megan; Rovny, Jared; Owen, J. Michael; Miller, Paul L.
2016-10-01
Stickney crater stretches across nearly half the diameter of ~22-km Phobos, the larger of the two martian moons. The Stickney-forming impact would have had global consequences for Phobos, causing extensive damage to the satellite's interior and initiating large-scale resurfacing through ejecta blanket emplacement. Further, much of the ejected material that initially escaped the moon's tiny gravity (escape velocity of ~11 m/s) would have likely reimpacted on subsequent orbits. Modeling of the impact event is necessary to understand the conditions that allowed this "megacrater" to form without disrupting the entire satellite. Impact simulation results also provide a means to test several different hypotheses for how the mysterious families of parallel grooves may have formed at Phobos.We report on adaptive SPH simulations that successfully generate Stickney while avoiding catastrophic fragmentation of Phobos. Inclusion of target porosity and using sufficient numerical resolution in fully 3-D simulations are key for avoiding over-estimation of target damage. Cratering efficiency follows gravity-dominated scaling laws over a wide range of velocities (6-20 km/s) for the appropriate material constants. While the adaptive SPH results are used to constrain crater volume and fracture patterns within the target, additional questions about the fate of ejecta and final crater morphology within an unusual gravity environment can be addressed with complementary numerical methods. Results from the end of the hydrodynamics-controlled phase (tens of seconds after impact) are linked to a Discrete Element Method code, which can explore these processes over longer time scales (see Schwartz et al., this meeting).This work was performed under the auspices of the U.S. Department of Energy by Lawrence Livermore National Laboratory under Contract DE-AC52-07NA27344. LLNL-ABS-695442.
Zhang, Qiu-xia; Liu, Hai-peng; Chen, Rong-yuan; Shen, Kai-li; Wang, Ke-jian
2013-01-01
Clip domain serine proteinase homologs are involved in many biological processes including immune response. To identify the immune function of a serine proteinase homolog (Sp-SPH), originally isolated from hemocytes of the mud crab, Scylla paramamosain, the Sp-SPH was expressed recombinantly and purified for further studies. It was found that the Sp-SPH protein could bind to a number of bacteria (including Aeromonas hydrophila, Escherichia coli, Staphylococcus aureus, Vibrio fluvialis, Vibrio harveyi and Vibrio parahemolyticus), bacterial cell wall components such as lipopolysaccharide or peptidoglycan (PGN), and β-1, 3-glucan of fungus. But no direct antibacterial activity of Sp-SPH protein was shown by using minimum inhibitory concentration or minimum bactericidal concentration assays. Nevertheless, the Sp-SPH protein was found to significantly enhance the crab hemocyte adhesion activity (paired t-test, P<0.05), and increase phenoloxidase activity if triggered by PGN in vitro (paired t-test, P<0.05). Importantly, the Sp-SPH protein was demonstrated to promote the survival rate of the animals after challenge with A. hydrophila or V. parahemolyticus which were both recognized by Sp-SPH protein, if pre-incubated with Sp-SPH protein, respectively. Whereas, the crabs died much faster when challenged with Vibrio alginolyiicus, a pathogenic bacterium not recognized by Sp-SPH protein, compared to those of crabs challenged with A. hydrophila or V. parahemolyticus when pre-coated with Sp-SPH protein. Taken together, these data suggested that Sp-SPH molecule might play an important role in immune defense against bacterial infection in the mud crab S. paramamosain. PMID:23724001
Zhang, Qiu-xia; Liu, Hai-peng; Chen, Rong-yuan; Shen, Kai-li; Wang, Ke-jian
2013-01-01
Clip domain serine proteinase homologs are involved in many biological processes including immune response. To identify the immune function of a serine proteinase homolog (Sp-SPH), originally isolated from hemocytes of the mud crab, Scylla paramamosain, the Sp-SPH was expressed recombinantly and purified for further studies. It was found that the Sp-SPH protein could bind to a number of bacteria (including Aeromonas hydrophila, Escherichia coli, Staphylococcus aureus, Vibrio fluvialis, Vibrio harveyi and Vibrio parahemolyticus), bacterial cell wall components such as lipopolysaccharide or peptidoglycan (PGN), and β-1, 3-glucan of fungus. But no direct antibacterial activity of Sp-SPH protein was shown by using minimum inhibitory concentration or minimum bactericidal concentration assays. Nevertheless, the Sp-SPH protein was found to significantly enhance the crab hemocyte adhesion activity (paired t-test, P<0.05), and increase phenoloxidase activity if triggered by PGN in vitro (paired t-test, P<0.05). Importantly, the Sp-SPH protein was demonstrated to promote the survival rate of the animals after challenge with A. hydrophila or V. parahemolyticus which were both recognized by Sp-SPH protein, if pre-incubated with Sp-SPH protein, respectively. Whereas, the crabs died much faster when challenged with Vibrio alginolyiicus, a pathogenic bacterium not recognized by Sp-SPH protein, compared to those of crabs challenged with A. hydrophila or V. parahemolyticus when pre-coated with Sp-SPH protein. Taken together, these data suggested that Sp-SPH molecule might play an important role in immune defense against bacterial infection in the mud crab S. paramamosain.
Integration of SPH Students with Non-Handicapped Peers at Pine Ridge Center.
ERIC Educational Resources Information Center
Pegnatore, Linda A.
A 9-week practicum was designed to integrate severely/profoundly handicapped (SPH) students with third-grade nonhandicapped peer tutors in Broward County, Florida. Additional Objectives were to promote greater understanding of handicaps by nonhandicapped peer tutors and to increase awareness by SPH teachers of the importance of interactions…
Zebrafish U6 small nuclear RNA gene promoters contain a SPH element in an unusual location.
Halbig, Kari M; Lekven, Arne C; Kunkel, Gary R
2008-09-15
Promoters for vertebrate small nuclear RNA (snRNA) genes contain a relatively simple array of transcriptional control elements, divided into proximal and distal regions. Most of these genes are transcribed by RNA polymerase II (e.g., U1, U2), whereas the U6 gene is transcribed by RNA polymerase III. Previously identified vertebrate U6 snRNA gene promoters consist of a proximal sequence element (PSE) and TATA element in the proximal region, plus a distal region with octamer (OCT) and SphI postoctamer homology (SPH) elements. We have found that zebrafish U6 snRNA promoters contain the SPH element in a novel proximal position immediately upstream of the TATA element. The zebrafish SPH element is recognized by SPH-binding factor/selenocysteine tRNA gene transcription activating factor/zinc finger protein 143 (SBF/Staf/ZNF143) in vitro. Furthermore, a zebrafish U6 promoter with a defective SPH element is inefficiently transcribed when injected into embryos.
Final report on LDRD project : coupling strategies for multi-physics applications.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Hopkins, Matthew Morgan; Moffat, Harry K.; Carnes, Brian
Many current and future modeling applications at Sandia including ASC milestones will critically depend on the simultaneous solution of vastly different physical phenomena. Issues due to code coupling are often not addressed, understood, or even recognized. The objectives of the LDRD has been both in theory and in code development. We will show that we have provided a fundamental analysis of coupling, i.e., when strong coupling vs. a successive substitution strategy is needed. We have enabled the implementation of tighter coupling strategies through additions to the NOX and Sierra code suites to make coupling strategies available now. We have leveragedmore » existing functionality to do this. Specifically, we have built into NOX the capability to handle fully coupled simulations from multiple codes, and we have also built into NOX the capability to handle Jacobi Free Newton Krylov simulations that link multiple applications. We show how this capability may be accessed from within the Sierra Framework as well as from outside of Sierra. The critical impact from this LDRD is that we have shown how and have delivered strategies for enabling strong Newton-based coupling while respecting the modularity of existing codes. This will facilitate the use of these codes in a coupled manner to solve multi-physic applications.« less
A serine proteinase homologue, SPH-3, plays a central role in insect immunity.
Felföldi, Gabriella; Eleftherianos, Ioannis; Ffrench-Constant, Richard H; Venekei, István
2011-04-15
Numerous vertebrate and invertebrate genes encode serine proteinase homologues (SPHs) similar to members of the serine proteinase family, but lacking one or more residues of the catalytic triad. These SPH proteins are thought to play a role in immunity, but their precise functions are poorly understood. In this study, we show that SPH-3 (an insect non-clip domain-containing SPH) is of central importance in the immune response of a model lepidopteran, Manduca sexta. We examine M. sexta infection with a virulent, insect-specific, Gram-negative bacterium Photorhabdus luminescens. RNA interference suppression of bacteria-induced SPH-3 synthesis severely compromises the insect's ability to defend itself against infection by preventing the transcription of multiple antimicrobial effector genes, but, surprisingly, not the transcription of immune recognition genes. Upregulation of the gene encoding prophenoloxidase and the activity of the phenoloxidase enzyme are among the antimicrobial responses that are severely attenuated on SPH-3 knockdown. These findings suggest the existence of two largely independent signaling pathways controlling immune recognition by the fat body, one governing effector gene transcription, and the other regulating genes encoding pattern recognition proteins.
Design and multi-physics optimization of rotary MRF brakes
NASA Astrophysics Data System (ADS)
Topcu, Okan; Taşcıoğlu, Yiğit; Konukseven, Erhan İlhan
2018-03-01
Particle swarm optimization (PSO) is a popular method to solve the optimization problems. However, calculations for each particle will be excessive when the number of particles and complexity of the problem increases. As a result, the execution speed will be too slow to achieve the optimized solution. Thus, this paper proposes an automated design and optimization method for rotary MRF brakes and similar multi-physics problems. A modified PSO algorithm is developed for solving multi-physics engineering optimization problems. The difference between the proposed method and the conventional PSO is to split up the original single population into several subpopulations according to the division of labor. The distribution of tasks and the transfer of information to the next party have been inspired by behaviors of a hunting party. Simulation results show that the proposed modified PSO algorithm can overcome the problem of heavy computational burden of multi-physics problems while improving the accuracy. Wire type, MR fluid type, magnetic core material, and ideal current inputs have been determined by the optimization process. To the best of the authors' knowledge, this multi-physics approach is novel for optimizing rotary MRF brakes and the developed PSO algorithm is capable of solving other multi-physics engineering optimization problems. The proposed method has showed both better performance compared to the conventional PSO and also has provided small, lightweight, high impedance rotary MRF brake designs.
NASA Astrophysics Data System (ADS)
Nardi, Albert; Idiart, Andrés; Trinchero, Paolo; de Vries, Luis Manuel; Molinero, Jorge
2014-08-01
This paper presents the development, verification and application of an efficient interface, denoted as iCP, which couples two standalone simulation programs: the general purpose Finite Element framework COMSOL Multiphysics® and the geochemical simulator PHREEQC. The main goal of the interface is to maximize the synergies between the aforementioned codes, providing a numerical platform that can efficiently simulate a wide number of multiphysics problems coupled with geochemistry. iCP is written in Java and uses the IPhreeqc C++ dynamic library and the COMSOL Java-API. Given the large computational requirements of the aforementioned coupled models, special emphasis has been placed on numerical robustness and efficiency. To this end, the geochemical reactions are solved in parallel by balancing the computational load over multiple threads. First, a benchmark exercise is used to test the reliability of iCP regarding flow and reactive transport. Then, a large scale thermo-hydro-chemical (THC) problem is solved to show the code capabilities. The results of the verification exercise are successfully compared with those obtained using PHREEQC and the application case demonstrates the scalability of a large scale model, at least up to 32 threads.
X-ray Modeling of η Carinae & WR140 from SPH Simulations
NASA Astrophysics Data System (ADS)
Russell, Christopher M. P.; Corcoran, Michael F.; Okazaki, Atsuo T.; Madura, Thomas I.; Owocki, Stanley P.
2011-01-01
The colliding wind binary (CWB) systems η Carinae and WR140 provide unique laboratories for X-ray astrophysics. Their wind-wind collisions produce hard X-rays that have been monitored extensively by several X-ray telescopes, including RXTE. To interpret these RXTE X-ray light curves, we model the wind-wind collision using 3D smoothed particle hydrodynamics (SPH) simulations. Adiabatic simulations that account for the emission and absorption of X-rays from an assumed point source at the apex of the wind-collision shock cone by the distorted winds can closely match the observed 2-10keV RXTE light curves of both η Car and WR140. This point-source model can also explain the early recovery of η Car's X-ray light curve from the 2009.0 minimum by a factor of 2-4 reduction in the mass loss rate of η Car. Our more recent models relax the point-source approximation and account for the spatially extended emission along the wind-wind interaction shock front. For WR140, the computed X-ray light curve again matches the RXTE observations quite well. But for η Car, a hot, post-periastron bubble leads to an emission level that does not match the extended X-ray minimum observed by RXTE. Initial results from incorporating radiative cooling and radiatively-driven wind acceleration via a new anti-gravity approach into the SPH code are also discussed.
Eichhöfer, Andreas; Buth, Gernot
2016-11-01
Reactions of [Co(N(SiMe 3 ) 2 ) 2 thf] with 2.1 equiv. of MesSH (Mes = C 6 H 2 -2,4,6-(CH 3 ) 3 ) yield dark brown crystals of the one dimensional chain compound [Co(SMes) 2 ]. In contrast reactions of [Co(N(SiMe 3 ) 2 ) 2 thf] with 2.1 equiv. of PhSH result in the formation of a dark brown almost X-ray amorphous powder of 'Co(SPh) 2 '. Addition of aliquots of CH 3 OH to the latter reaction resulted in the almost quantitative formation of crystalline ammonia thiolato complexes either [Co(SPh) 2 (NH 3 ) 2 ] or [Co(SPh) 2 NH 3 ]. Single crystal XRD reveals that [Co(SPh) 2 NH 3 ] forms one-dimensional chains in the crystal via μ 2 -SPh bridges whereas [Co(SPh) 2 (NH 3 ) 2 ] consists at a first glance of isolated distorted tetrahedral units. Magnetic measurements suggest strong antiferromagnetic coupling for the two chain compounds [Co(SMes) 2 ] (J = -38.6 cm -1 ) and [Co(SPh) 2 NH 3 ] (J = -27.1 cm -1 ). Interestingly, also the temperature dependence of the susceptibility of tetrahedral [Co(SPh) 2 (NH 3 ) 2 ] shows an antiferromagnetic transition at around 6 K. UV-Vis-NIR spectra display d-d bands in the NIR region between 500 and 2250 nm. Thermal gravimetric analysis of [Co(SPh) 2 (NH 3 ) 2 ] and [Co(SPh) 2 NH 3 ] reveals two well separated cleavage processes for NH 3 and SPh 2 upon heating accompanied by the stepwise formation of 'Co(SPh) 2 ' and cobalt sulfide.
FEM and Multiphysics Applications at NASA/GSFC
NASA Technical Reports Server (NTRS)
Loughlin, James
2004-01-01
FEM software available to the Mechanical Systems Analysis and Simulation Branch at Goddard Space Flight Center (GSFC) include: 1) MSC/Nastran; 2) Abaqus; 3) Ansys/Multiphysics; 4) COSMOS/M; 5) 'Home-grown' programs; 6) Pre/post processors such as Patran and FEMAP. This viewgraph presentation provides additional information on MSC/Nastran and Ansys/Multiphysics, and includes screen shots of analyzed equipment, including the Wilkinson Microwave Anistropy Probe, a micro-mirror, a MEMS tunable filter, and a micro-shutter array. The presentation also includes information on the verification of results.
Molecular definition of red cell Rh haplotypes by tightly linked SphI RFLPs.
Huang, C H; Reid, M E; Chen, Y; Coghlan, G; Okubo, Y
1996-01-01
The Rh blood group system of human red cells contains five major antigens D, C/c, and E/e (the latter four designated "non-D") that are specified by eight gene complexes known as Rh haplotypes. In this paper, we report on the mapping of RH locus and identification of a set of SphI RFLPs that are tightly linked with the Rh structural genes. Using exon-specific probes, we have localized the SphI cleavage sites resulting in these DNA markers and derived a comprehensive map for the RH locus. It was found that the SphI fragments encompassing exons 4-7 of the Rh genes occur in four banding patterns or frameworks that correspond to the distribution and segregation of the common Rh haplotypes. This linkage disequilibrium allowed a genotype-phenotype correlation and direct determination of Rh zygosity related to the Rh-positive or Rh-negative status (D/D, D/d, and d/d). Studies on the occurrence of SphI RFLPs in a number of rare Rh variants indicated that Rh phenotypic diversity has taken place on different haplotype backgrounds and has arisen by diverse genetic mechanisms. The molecular definition of Rh haplotypes by SphI RFLP frameworks should provide a useful procedure for genetic counseling and prenatal assessment of Rh alloimmunization.
NASA Astrophysics Data System (ADS)
Slaughter, A. E.; Permann, C.; Peterson, J. W.; Gaston, D.; Andrs, D.; Miller, J.
2014-12-01
The Idaho National Laboratory (INL)-developed Multiphysics Object Oriented Simulation Environment (MOOSE; www.mooseframework.org), is an open-source, parallel computational framework for enabling the solution of complex, fully implicit multiphysics systems. MOOSE provides a set of computational tools that scientists and engineers can use to create sophisticated multiphysics simulations. Applications built using MOOSE have computed solutions for chemical reaction and transport equations, computational fluid dynamics, solid mechanics, heat conduction, mesoscale materials modeling, geomechanics, and others. To facilitate the coupling of diverse and highly-coupled physical systems, MOOSE employs the Jacobian-free Newton-Krylov (JFNK) method when solving the coupled nonlinear systems of equations arising in multiphysics applications. The MOOSE framework is written in C++, and leverages other high-quality, open-source scientific software packages such as LibMesh, Hypre, and PETSc. MOOSE uses a "hybrid parallel" model which combines both shared memory (thread-based) and distributed memory (MPI-based) parallelism to ensure efficient resource utilization on a wide range of computational hardware. MOOSE-based applications are inherently modular, which allows for simulation expansion (via coupling of additional physics modules) and the creation of multi-scale simulations. Any application developed with MOOSE supports running (in parallel) any other MOOSE-based application. Each application can be developed independently, yet easily communicate with other applications (e.g., conductivity in a slope-scale model could be a constant input, or a complete phase-field micro-structure simulation) without additional code being written. This method of development has proven effective at INL and expedites the development of sophisticated, sustainable, and collaborative simulation tools.
Development of high-fidelity multiphysics system for light water reactor analysis
NASA Astrophysics Data System (ADS)
Magedanz, Jeffrey W.
There has been a tendency in recent years toward greater heterogeneity in reactor cores, due to the use of mixed-oxide (MOX) fuel, burnable absorbers, and longer cycles with consequently higher fuel burnup. The resulting asymmetry of the neutron flux and energy spectrum between regions with different compositions causes a need to account for the directional dependence of the neutron flux, instead of the traditional diffusion approximation. Furthermore, the presence of both MOX and high-burnup fuel in the core increases the complexity of the heat conduction. The heat transfer properties of the fuel pellet change with irradiation, and the thermal and mechanical expansion of the pellet and cladding strongly affect the size of the gap between them, and its consequent thermal resistance. These operational tendencies require higher fidelity multi-physics modeling capabilities, and this need is addressed by the developments performed within this PhD research. The dissertation describes the development of a High-Fidelity Multi-Physics System for Light Water Reactor Analysis. It consists of three coupled codes -- CTF for Thermal Hydraulics, TORT-TD for Neutron Kinetics, and FRAPTRAN for Fuel Performance. It is meant to address these modeling challenges in three ways: (1) by resolving the state of the system at the level of each fuel pin, rather than homogenizing entire fuel assemblies, (2) by using the multi-group Discrete Ordinates method to account for the directional dependence of the neutron flux, and (3) by using a fuel-performance code, rather than a Thermal Hydraulics code's simplified fuel model, to account for the material behavior of the fuel and its feedback to the hydraulic and neutronic behavior of the system. While the first two are improvements, the third, the use of a fuel-performance code for feedback, constitutes an innovation in this PhD project. Also important to this work is the manner in which such coupling is written. While coupling involves combining
DOE Office of Scientific and Technical Information (OSTI.GOV)
Kim, Seung Jun; Buechler, Cynthia Eileen
The current study aims to predict the steady state power of a generic solution vessel and to develop a corresponding heat transfer coefficient correlation for a Moly99 production facility by conducting a fully coupled multi-physics simulation. A prediction of steady state power for the current application is inherently interconnected between thermal hydraulic characteristics (i.e. Multiphase computational fluid dynamics solved by ANSYS-Fluent 17.2) and the corresponding neutronic behavior (i.e. particle transport solved by MCNP6.2) in the solution vessel. Thus, the development of a coupling methodology is vital to understand the system behavior at a variety of system design and postulated operatingmore » scenarios. In this study, we report on the k-effective (keff) calculation for the baseline solution vessel configuration with a selected solution concentration using MCNP K-code modeling. The associated correlation of thermal properties (e.g. density, viscosity, thermal conductivity, specific heat) at the selected solution concentration are developed based on existing experimental measurements in the open literature. The numerical coupling methodology between multiphase CFD and MCNP is successfully demonstrated, and the detailed coupling procedure is documented. In addition, improved coupling methods capturing realistic physics in the solution vessel thermal-neutronic dynamics are proposed and tested further (i.e. dynamic height adjustment, mull-cell approach). As a key outcome of the current study, a multi-physics coupling methodology between MCFD and MCNP is demonstrated and tested for four different operating conditions. Those different operating conditions are determined based on the neutron source strength at a fixed geometry condition. The steady state powers for the generic solution vessel at various operating conditions are reported, and a generalized correlation of the heat transfer coefficient for the current application is discussed. The assessment of
NASA Astrophysics Data System (ADS)
Raymond, Samuel J.; Jones, Bruce; Williams, John R.
2018-01-01
A strategy is introduced to allow coupling of the material point method (MPM) and smoothed particle hydrodynamics (SPH) for numerical simulations. This new strategy partitions the domain into SPH and MPM regions, particles carry all state variables and as such no special treatment is required for the transition between regions. The aim of this work is to derive and validate the coupling methodology between MPM and SPH. Such coupling allows for general boundary conditions to be used in an SPH simulation without further augmentation. Additionally, as SPH is a purely particle method, and MPM is a combination of particles and a mesh. This coupling also permits a smooth transition from particle methods to mesh methods, where further coupling to mesh methods could in future provide an effective farfield boundary treatment for the SPH method. The coupling technique is introduced and described alongside a number of simulations in 1D and 2D to validate and contextualize the potential of using these two methods in a single simulation. The strategy shown here is capable of fully coupling the two methods without any complicated algorithms to transform information from one method to another.
NASA Astrophysics Data System (ADS)
Xu, Xiaoyang; Deng, Xiao-Long
2016-04-01
In this paper, an improved weakly compressible smoothed particle hydrodynamics (SPH) method is proposed to simulate transient free surface flows of viscous and viscoelastic fluids. The improved SPH algorithm includes the implementation of (i) the mixed symmetric correction of kernel gradient to improve the accuracy and stability of traditional SPH method and (ii) the Rusanov flux in the continuity equation for improving the computation of pressure distributions in the dynamics of liquids. To assess the effectiveness of the improved SPH algorithm, a number of numerical examples including the stretching of an initially circular water drop, dam breaking flow against a vertical wall, the impact of viscous and viscoelastic fluid drop with a rigid wall, and the extrudate swell of viscoelastic fluid have been presented and compared with available numerical and experimental data in literature. The convergent behavior of the improved SPH algorithm has also been studied by using different number of particles. All numerical results demonstrate that the improved SPH algorithm proposed here is capable of modeling free surface flows of viscous and viscoelastic fluids accurately and stably, and even more important, also computing an accurate and little oscillatory pressure field.
Molecular definition of red cell Rh haplotypes by tightly linked SphI RFLPs
DOE Office of Scientific and Technical Information (OSTI.GOV)
Huang, C.H.; Reid, M.E.; Chen, Y.
The Rh blood group system of human red cells contains five major antigens D, C/c, and E/e (the latter four designated {open_quotes}non-D{close_quotes}) that are specified by eight gene complexes known as Rh haplotypes. In this paper, we report on the mapping of the RH locus and identification of a set of SphI RFLPs that are tightly linked with the Rh structural genes. Using exon-specific probes, we have localized the SphI cleavage sites resulting in these DNA markers and derived a comprehensive map for the RH locus. It was found that the SphI fragments encompassing exons 4-7 of the Rh genesmore » occur in four banding patterns or frameworks that correspond to the distribution and segregation of the common Rh haplotypes. This linkage disequilibrium allowed a genotype-phenotype correlation and direct determination of Rh zygosity related to the Rh-positive or Rh-negative status (D/D, D/d, and d/d). Studies on the occurrence of SphI RFLPs in a number of rare Rh variants indicated that Rh phenotypic diversity has taken place on different haplotype backgrounds and has arisen by diverse genetic mechanisms. The molecular definition of Rh haplotypes by SphI RFLP frameworks should provide a useful procedure for genetic counseling and prenatal assessment of Rh alloimmunization. 32 refs., 7 figs., 3 tabs.« less
Quercetin ameliorates pulmonary fibrosis by inhibiting SphK1/S1P signaling.
Zhang, Xingcai; Cai, Yuli; Zhang, Wei; Chen, Xianhai
2018-06-25
Idiopathic pulmonary fibrosis (IPF) is an agnogenic chronic disorder with high morbidity and low survival rate. Quercetin is a flavonoid found in a variety of herbs with anti-fibrosis function. In this study, bleomycin was employed to induce a pulmonary fibrosis mouse model. The quercetin administration ameliorated bleomycin-induced pulmonary fibrosis, evidenced by the expression level changes of hydroxyproline, fibronectin, α-smooth muscle actin, Collagen I and Collagen III. The similar results were observed in transforming growth factor (TGF)-β-treated human embryonic lung fibroblast (HELF). The bleomycin or TGF-β administration caused the increase of sphingosine-1-phosphate (S1P) level in pulmonary tissue and HELF cells, as well as its activation-required kinase, sphingosine kinase 1 (SphK1), and its degradation enzyme, sphinogosine-1-phosphate lyase (S1PL). However, the increase of S1P, SphK1 and S1PL was attenuated by application of quercetin. In addition, the effect of quercetin on fibrosis was abolished by the ectopic expression of SphK1. The colocalization of SphK1/S1PL and fibroblast specific protein 1 (FSP1) suggested the roles of fibroblasts in pulmonary fibrosis. In summary, we demonstrated that quercetin ameliorated pulmonary fibrosis in vivo and in vitro by inhibiting SphK1/S1P signaling.
Incompressible SPH (ISPH) with fast Poisson solver on a GPU
NASA Astrophysics Data System (ADS)
Chow, Alex D.; Rogers, Benedict D.; Lind, Steven J.; Stansby, Peter K.
2018-05-01
This paper presents a fast incompressible SPH (ISPH) solver implemented to run entirely on a graphics processing unit (GPU) capable of simulating several millions of particles in three dimensions on a single GPU. The ISPH algorithm is implemented by converting the highly optimised open-source weakly-compressible SPH (WCSPH) code DualSPHysics to run ISPH on the GPU, combining it with the open-source linear algebra library ViennaCL for fast solutions of the pressure Poisson equation (PPE). Several challenges are addressed with this research: constructing a PPE matrix every timestep on the GPU for moving particles, optimising the limited GPU memory, and exploiting fast matrix solvers. The ISPH pressure projection algorithm is implemented as 4 separate stages, each with a particle sweep, including an algorithm for the population of the PPE matrix suitable for the GPU, and mixed precision storage methods. An accurate and robust ISPH boundary condition ideal for parallel processing is also established by adapting an existing WCSPH boundary condition for ISPH. A variety of validation cases are presented: an impulsively started plate, incompressible flow around a moving square in a box, and dambreaks (2-D and 3-D) which demonstrate the accuracy, flexibility, and speed of the methodology. Fragmentation of the free surface is shown to influence the performance of matrix preconditioners and therefore the PPE matrix solution time. The Jacobi preconditioner demonstrates robustness and reliability in the presence of fragmented flows. For a dambreak simulation, GPU speed ups demonstrate up to 10-18 times and 1.1-4.5 times compared to single-threaded and 16-threaded CPU run times respectively.
Okino, Nozomu; Ito, Makoto
2016-01-01
Pseudomonas aeruginosa, an opportunistic, but serious multidrug-resistant pathogen, secretes a ceramidase capable of cleaving the N-acyl linkage of ceramide to generate fatty acids and sphingosine. We previously reported that the secretion of P. aeruginosa ceramidase was induced by host-derived sphingolipids, through which phospholipase C-induced hemolysis was significantly enhanced. We herein investigated the gene(s) regulating sphingolipid-induced ceramidase expression and identified SphR, which encodes a putative AraC family transcriptional regulator. Disruption of the sphR gene in P. aeruginosa markedly decreased the sphingomyelin-induced secretion of ceramidase, reduced hemolytic activity, and resulted in the loss of sphingomyelin-induced ceramidase expression. A microarray analysis confirmed that sphingomyelin significantly induced ceramidase expression in P. aeruginosa. Furthermore, an electrophoretic mobility shift assay revealed that SphR specifically bound free sphingoid bases such as sphingosine, dihydrosphingosine, and phytosphingosine, but not sphingomyelin or ceramide. A β-galactosidase-assisted promoter assay showed that sphingosine activated ceramidase expression through SphR at a concentration of 100 nM. Collectively, these results demonstrated that sphingosine induces the secretion of ceramidase by promoting the mRNA expression of ceramidase through SphR, thereby enhancing hemolytic phospholipase C-induced cytotoxicity. These results facilitate understanding of the physiological role of bacterial ceramidase in host cells. PMID:27941831
Dorkoosh, Farid A; Borchard, Gerrit; Rafiee-Tehrani, Morteza; Verhoef, J Coos; Junginger, Hans E
2002-03-01
The objective of this study was to investigate the potential of superporous hydrogel (SPH) and SPH composite (SPHC) polymers to enhance the transport of N-alpha-benzoyl-L-arginine ethylester (BAEE) and fluorescein isothiocyanate-dextran 4400 (FD4) across porcine intestinal epithelium ex-vivo, and to study any possible morphological damage to the epithelium by applying these polymers. In addition, the ability of these polymers to attach to the gut wall by mechanical pressure was examined by using a specifically designed centrifuge model. The transport of BAEE and FD4 across the intestinal mucosa was enhanced 2- to 3-fold by applying SPHC polymer in comparison to negative control. No significant morphological damage was observed by applying these polymers inside the intestinal lumen. Moreover, the SPH and SPHC polymers were able to attach mechanically to the intestinal wall by swelling and did not move in the intestinal lumen even when a horizontal force of 13 gms(-2) was applied. In conclusion, these polymers are appropriate vehicles for enhancing the intestinal absorption of peptide and protein drugs.
Continuum modeling of rate-dependent granular flows in SPH
Hurley, Ryan C.; Andrade, José E.
2016-09-13
In this paper, we discuss a constitutive law for modeling rate-dependent granular flows that has been implemented in smoothed particle hydrodynamics (SPH). We model granular materials using a viscoplastic constitutive law that produces a Drucker–Prager-like yield condition in the limit of vanishing flow. A friction law for non-steady flows, incorporating rate-dependence and dilation, is derived and implemented within the constitutive law. We compare our SPH simulations with experimental data, demonstrating that they can capture both steady and non-steady dynamic flow behavior, notably including transient column collapse profiles. In conclusion, this technique may therefore be attractive for modeling the time-dependent evolutionmore » of natural and industrial flows.« less
A technique to remove the tensile instability in weakly compressible SPH
NASA Astrophysics Data System (ADS)
Xu, Xiaoyang; Yu, Peng
2018-01-01
When smoothed particle hydrodynamics (SPH) is directly applied for the numerical simulations of transient viscoelastic free surface flows, a numerical problem called tensile instability arises. In this paper, we develop an optimized particle shifting technique to remove the tensile instability in SPH. The basic equations governing free surface flow of an Oldroyd-B fluid are considered, and approximated by an improved SPH scheme. This includes the implementations of the correction of kernel gradient and the introduction of Rusanov flux into the continuity equation. To verify the effectiveness of the optimized particle shifting technique in removing the tensile instability, the impacting drop, the injection molding of a C-shaped cavity, and the extrudate swell, are conducted. The numerical results obtained are compared with those simulated by other numerical methods. A comparison among different numerical techniques (e.g., the artificial stress) to remove the tensile instability is further performed. All numerical results agree well with the available data.
Li, Gao; Zeng, Chenjie; Jin, Rongchao
2014-03-05
We report the synthesis and catalytic application of thermally robust gold nanoclusters formulated as Au99(SPh)42. The formula was determined by electrospray ionization and matrix-assisted laser desorption ionization mass spectrometry in conjunction with thermogravimetric analysis. The optical spectrum of Au99(SPh)42 nanoclusters shows absorption peaks at ~920 nm (1.35 eV), 730 nm (1.70 eV), 600 nm (2.07 eV), 490 nm (2.53 eV), and 400 nm (3.1 eV) in contrast to conventional gold nanoparticles, which exhibit a plasmon resonance band at 520 nm (for spherical particles). The ceria-supported Au99(SPh)42 nanoclusters were utilized as a catalyst for chemoselective hydrogenation of nitrobenzaldehyde to nitrobenzyl alcohol in water using H2 gas as the hydrogen source. The selective hydrogenation of the aldehyde group catalyzed by nanoclusters is a surprise because conventional nanogold catalysts instead give rise to the product resulting from reduction of the nitro group. The Au99(SPh)42/CeO2 catalyst gives high catalytic activity for a range of nitrobenzaldehyde derivatives and also shows excellent recyclability due to its thermal robustness. We further tested the size-dependent catalytic performance of Au25(SPh)18 and Au36(SPh)24 nanoclusters, and on the basis of their crystal structures we propose a molecular adsorption site for nitrobenzaldehyde. The nanocluster material is expected to find wide application in catalytic reactions.
Lee, Gileung; Lee, Kang-Ie; Lee, Yunjoo; Kim, Backki; Lee, Dongryung; Seo, Jeonghwan; Jang, Su; Chin, Joong Hyoun; Koh, Hee-Jong
2018-07-01
The split-hull phenotype caused by reduced lemma width and low lignin content is under control of SPH encoding a type-2 13-lipoxygenase and contributes to high dehulling efficiency. Rice hulls consist of two bract-like structures, the lemma and palea. The hull is an important organ that helps to protect seeds from environmental stress, determines seed shape, and ensures grain filling. Achieving optimal hull size and morphology is beneficial for seed development. We characterized the split-hull (sph) mutant in rice, which exhibits hull splitting in the interlocking part between lemma and palea and/or the folded part of the lemma during the grain filling stage. Morphological and chemical analysis revealed that reduction in the width of the lemma and lignin content of the hull in the sph mutant might be the cause of hull splitting. Genetic analysis indicated that the mutant phenotype was controlled by a single recessive gene, sph (Os04g0447100), which encodes a type-2 13-lipoxygenase. SPH knockout and knockdown transgenic plants displayed the same split-hull phenotype as in the mutant. The sph mutant showed significantly higher linoleic and linolenic acid (substrates of lipoxygenase) contents in spikelets compared to the wild type. It is probably due to the genetic defect of SPH and subsequent decrease in lipoxygenase activity. In dehulling experiment, the sph mutant showed high dehulling efficiency even by a weak tearing force in a dehulling machine. Collectively, the results provide a basis for understanding of the functional role of lipoxygenase in structure and maintenance of hulls, and would facilitate breeding of easy-dehulling rice.
Local Group dSph radio survey with ATCA (III): constraints on particle dark matter
NASA Astrophysics Data System (ADS)
Regis, Marco; Colafrancesco, Sergio; Profumo, Stefano; de Blok, W. J. G.; Massardi, Marcella; Richter, Laura
2014-10-01
We performed a deep search for radio synchrotron emissions induced by weakly interacting massive particles (WIMPs) annihilation or decay in six dwarf spheroidal (dSph) galaxies of the Local Group. Observations were conducted with the Australia Telescope Compact Array (ATCA) at 16 cm wavelength, with an rms sensitivity better than 0.05 mJy/beam in each field. In this work, we first discuss the uncertainties associated with the modeling of the expected signal, such as the shape of the dark matter (DM) profile and the dSph magnetic properties. We then investigate the possibility that point-sources detected in the proximity of the dSph optical center might be due to the emission from a DM cuspy profile. No evidence for an extended emission over a size of few arcmin (which is the DM halo size) has been detected. We present the associated bounds on the WIMP parameter space for different annihilation/decay final states and for different astrophysical assumptions. If the confinement of electrons and positrons in the dSph is such that the majority of their power is radiated within the dSph region, we obtain constraints on the WIMP annihilation rate which are well below the thermal value for masses up to few TeV. On the other hand, for conservative assumptions on the dSph magnetic properties, the bounds can be dramatically relaxed. We show however that, within the next 10 years and regardless of the astrophysical assumptions, it will be possible to progressively close in on the full parameter space of WIMPs by searching for radio signals in dSphs with SKA and its precursors.
Jearaphunt, Miti; Amparyup, Piti; Sangsuriya, Pakkakul; Charoensapsri, Walaiporn; Senapin, Saengchan; Tassanakajon, Anchalee
2015-01-01
Melanization mediated by the prophenoloxidase (proPO) activating system is a rapid immune response used by invertebrates against intruding pathogens. Several masquerade-like and serine proteinase homologues (SPHs) have been demonstrated to play an essential role in proPO activation in insects and crustaceans. In a previous study, we characterized the masquerade-like SPH, PmMasSPH1, in the black tiger shrimp Penaeus monodon as a multifunctional immune protein based on its recognition and antimicrobial activity against the Gram-negative bacteria Vibrio harveyi. In the present study, we identify a novel SPH, known as PmMasSPH2, composed of an N-terminal clip domain and a C-terminal SP-like domain that share high similarity to those of other insect and crustacean SPHs. We demonstrate that gene silencing of PmMasSPH1 and PmMasSPH2 significantly reduces PO activity, resulting in a high number of V. harveyi in the hemolymph. Interestingly, knockdown of PmMasSPH1 suppressed not only its gene transcript but also other immune-related genes in the proPO system (e.g., PmPPAE2) and antimicrobial peptides (e.g., PenmonPEN3, PenmonPEN5, crustinPm1 and Crus-likePm). The PmMasSPH1 and PmMasSPH2 also show binding activity to peptidoglycan (PGN) of Gram-positive bacteria. Using a yeast two-hybrid analysis and co-immunoprecipitation, we demonstrate that PmMasSPH1 specifically interacted with the final proteinase of the proPO cascade, PmPPAE2. Furthermore, the presence of both PmMasSPH1 and PmPPAE2 enhances PGN-induced PO activity in vitro. Taken together, these results suggest the importance of PmMasSPHs in the activation of the shrimp proPO system.
Jearaphunt, Miti; Amparyup, Piti; Sangsuriya, Pakkakul; Charoensapsri, Walaiporn; Senapin, Saengchan; Tassanakajon, Anchalee
2015-01-01
Melanization mediated by the prophenoloxidase (proPO) activating system is a rapid immune response used by invertebrates against intruding pathogens. Several masquerade-like and serine proteinase homologues (SPHs) have been demonstrated to play an essential role in proPO activation in insects and crustaceans. In a previous study, we characterized the masquerade-like SPH, PmMasSPH1, in the black tiger shrimp Penaeus monodon as a multifunctional immune protein based on its recognition and antimicrobial activity against the Gram-negative bacteria Vibrio harveyi. In the present study, we identify a novel SPH, known as PmMasSPH2, composed of an N-terminal clip domain and a C-terminal SP-like domain that share high similarity to those of other insect and crustacean SPHs. We demonstrate that gene silencing of PmMasSPH1 and PmMasSPH2 significantly reduces PO activity, resulting in a high number of V. harveyi in the hemolymph. Interestingly, knockdown of PmMasSPH1 suppressed not only its gene transcript but also other immune-related genes in the proPO system (e.g., PmPPAE2) and antimicrobial peptides (e.g., PenmonPEN3, PenmonPEN5, crustinPm1 and Crus-likePm). The PmMasSPH1 and PmMasSPH2 also show binding activity to peptidoglycan (PGN) of Gram-positive bacteria. Using a yeast two-hybrid analysis and co-immunoprecipitation, we demonstrate that PmMasSPH1 specifically interacted with the final proteinase of the proPO cascade, PmPPAE2. Furthermore, the presence of both PmMasSPH1 and PmPPAE2 enhances PGN-induced PO activity in vitro. Taken together, these results suggest the importance of PmMasSPHs in the activation of the shrimp proPO system. PMID:25803442
Incompressible SPH Model for Simulating Violent Free-Surface Fluid Flows
NASA Astrophysics Data System (ADS)
Staroszczyk, Ryszard
2014-06-01
In this paper the problem of transient gravitational wave propagation in a viscous incompressible fluid is considered, with a focus on flows with fast-moving free surfaces. The governing equations of the problem are solved by the smoothed particle hydrodynamics method (SPH). In order to impose the incompressibility constraint on the fluid motion, the so-called projection method is applied in which the discrete SPH equations are integrated in time by using a fractional-step technique. Numerical performance of the proposed model has been assessed by comparing its results with experimental data and with results obtained by a standard (weakly compressible) version of the SPH approach. For this purpose, a plane dam-break flow problem is simulated, in order to investigate the formation and propagation of a wave generated by a sudden collapse of a water column initially contained in a rectangular tank, as well as the impact of such a wave on a rigid vertical wall. The results of simulations show the evolution of the free surface of water, the variation of velocity and pressure fields in the fluid, and the time history of pressures exerted by an impacting wave on a wall.
Local Group dSph radio survey with ATCA - II. Non-thermal diffuse emission
NASA Astrophysics Data System (ADS)
Regis, Marco; Richter, Laura; Colafrancesco, Sergio; Profumo, Stefano; de Blok, W. J. G.; Massardi, Marcella
2015-04-01
Our closest neighbours, the Local Group dwarf spheroidal (dSph) galaxies, are extremely quiescent and dim objects, where thermal and non-thermal diffuse emissions lack, so far, of detection. In order to possibly study the dSph interstellar medium, deep observations are required. They could reveal non-thermal emissions associated with the very low level of star formation, or to particle dark matter annihilating or decaying in the dSph halo. In this work, we employ radio observations of six dSphs, conducted with the Australia Telescope Compact Array in the frequency band 1.1-3.1 GHz, to test the presence of a diffuse component over typical scales of few arcmin and at an rms sensitivity below 0.05 mJy beam-1. We observed the dSph fields with both a compact array and long baselines. Short spacings led to a synthesized beam of about 1 arcmin and were used for the extended emission search. The high-resolution data mapped background sources, which in turn were subtracted in the short-baseline maps, to reduce their confusion limit. We found no significant detection of a diffuse radio continuum component. After a detailed discussion on the modelling of the cosmic ray (CR) electron distribution and on the dSph magnetic properties, we present bounds on several physical quantities related to the dSphs, such that the total radio flux, the angular shape of the radio emissivity, the equipartition magnetic field, and the injection and equilibrium distributions of CR electrons. Finally, we discuss the connection to far-infrared and X-ray observations.
Cui, Zhen; Henderson, Richard A
2002-08-12
Kinetic studies, using stopped-flow spectrophotometry, on the reactions of [M(4)(SPh)(10)](2)(-) (M = Fe or Co) with PhS(-) to form [M(SPh)(4)](2)(-) are described, as are the reactions between [M(4)(SPh)(10)](2)(-) and [MoS(4)](2)(-) to form [S(2)MoS(2)Fe(SPh)(2)](2)(-) or [S(2)MoS(2)CoS(2)MoS(2)](2)(-). The kinetics of the reactions with PhS(-) are consistent with an initial associative substitution mechanism involving attack of PhS(-) at one of the tetrahedral M sites of [M(4)(SPh)(10)](2)(-) to form [M(4)(SPh)(11)](3)(-). Subsequent or concomitant cleavage of a micro-SPh ligand, at the same M, initiates a cascade of rapid reactions which result ultimately in the complete rupture of the cluster and formation of [M(SPh)(4)](2)(-). The kinetics of the reaction between [M(4)(SPh)(10)](2)(-) and [MoS(4)](2)(-) indicate an initial dissociative substitution mechanism at low concentrations of [MoS(4)](2)(-), in which rate-limiting dissociation of a terminal thiolate from [M(4)(SPh)(10)](2)(-) produces [M(4)(SPh)(9)](-) and the coordinatively unsaturated M site is rapidly attacked by a sulfido group of [MoS(4)](2)(-). It is proposed that subsequent chelation of the MoS(4) ligand results in cleavage of an M-micro-SPh bond, initiating a cascade of reactions which lead to the ultimate break-up of the cluster and formation of the products, [S(2)MoS(2)Fe(SPh)(2)](2)(-) or [S(2)MoS(2)CoS(2)MoS(2)](2)(-). With [Co(4)(SPh)(10)](2)(-), at higher concentrations of [MoS(4)](2)(-), a further substitution pathway is evident which exhibits a second order dependence on the concentration of [MoS(4)](2)(-). The mechanistic picture of cluster disruption which emerges from these studies rationalizes the "all or nothing" reactivity of [M(4)(SPh)(10)](2)(-).
Multi-resolution Delta-plus-SPH with tensile instability control: Towards high Reynolds number flows
NASA Astrophysics Data System (ADS)
Sun, P. N.; Colagrossi, A.; Marrone, S.; Antuono, M.; Zhang, A. M.
2018-03-01
It is well known that the use of SPH models in simulating flow at high Reynolds numbers is limited because of the tensile instability inception in the fluid region characterized by high vorticity and negative pressure. In order to overcome this issue, the δ+-SPH scheme is modified by implementing a Tensile Instability Control (TIC). The latter consists of switching the momentum equation to a non-conservative formulation in the unstable flow regions. The loss of conservation properties is shown to induce small errors, provided that the particle distribution is regular. The latter condition can be ensured thanks to the implementation of a Particle Shifting Technique (PST). The novel variant of the δ+-SPH is proved to be effective in preventing the onset of tensile instability. Several challenging benchmark tests involving flows past bodies at large Reynolds numbers have been used. Within this a simulation characterized by a deforming foil that resembles a fish-like swimming body is used as a practical application of the δ+-SPH model in biological fluid mechanics.
Efficient high-quality volume rendering of SPH data.
Fraedrich, Roland; Auer, Stefan; Westermann, Rüdiger
2010-01-01
High quality volume rendering of SPH data requires a complex order-dependent resampling of particle quantities along the view rays. In this paper we present an efficient approach to perform this task using a novel view-space discretization of the simulation domain. Our method draws upon recent work on GPU-based particle voxelization for the efficient resampling of particles into uniform grids. We propose a new technique that leverages a perspective grid to adaptively discretize the view-volume, giving rise to a continuous level-of-detail sampling structure and reducing memory requirements compared to a uniform grid. In combination with a level-of-detail representation of the particle set, the perspective grid allows effectively reducing the amount of primitives to be processed at run-time. We demonstrate the quality and performance of our method for the rendering of fluid and gas dynamics SPH simulations consisting of many millions of particles.
Mingus Discontinuous Multiphysics
DOE Office of Scientific and Technical Information (OSTI.GOV)
Pat Notz, Dan Turner
Mingus provides hybrid coupled local/non-local mechanics analysis capabilities that extend several traditional methods to applications with inherent discontinuities. Its primary features include adaptations of solid mechanics, fluid dynamics and digital image correlation that naturally accommodate dijointed data or irregular solution fields by assimilating a variety of discretizations (such as control volume finite elements, peridynamics and meshless control point clouds). The goal of this software is to provide an analysis framework form multiphysics engineering problems with an integrated image correlation capability that can be used for experimental validation and model
Granata, R; Trovato, L; Lupia, E; Sala, G; Settanni, F; Camussi, G; Ghidoni, R; Ghigo, E
2007-04-01
Angiogenesis is critical for development and repair, and is a prominent feature of many pathological conditions. Based on evidence that insulin-like growth factor binding protein (IGFBP)-3 enhances cell motility and activates sphingosine kinase (SphK) in human endothelial cells, we have investigated whether IGFBP-3 plays a role in promoting angiogenesis. IGFBP-3 potently induced network formation by human endothelial cells on Matrigel. Moreover, it up-regulated proangiogenic genes, such as vascular endothelial growth factor (VEGF) and matrix metalloproteinases (MMP)-2 and -9. IGFBP-3 even induced membrane-type 1 MMP (MT1-MMP), which regulates MMP-2 activation. Decreasing SphK1 expression by small interfering RNA (siRNA), blocked IGFBP-3-induced network formation and inhibited VEGF, MT1-MMP but not IGF-I up-regulation. IGF-I activated SphK, leading to sphingosine-1-phosphate (S1P) formation. The IGF-I effect on SphK activity was blocked by specific inhibitors of IGF-IR, PI3K/Akt and ERK1/2 phosphorylation. The disruption of IGF-I signaling prevented the IGFBP-3 effect on tube formation, SphK activity and VEGF release. Blocking ERK1/2 signaling caused the loss of SphK activation and VEGF and IGF-I up-regulation. Finally, IGFBP-3 dose-dependently stimulated neovessel formation into subcutaneous implants of Matrigel in vivo. Thus, IGFBP-3 positively regulates angiogenesis through involvement of IGF-IR signaling and subsequent SphK/S1P activation.
Two-dimensional free-surface flow under gravity: A new benchmark case for SPH method
NASA Astrophysics Data System (ADS)
Wu, J. Z.; Fang, L.
2018-02-01
Currently there are few free-surface benchmark cases with analytical results for the Smoothed Particle Hydrodynamics (SPH) simulation. In the present contribution we introduce a two-dimensional free-surface flow under gravity, and obtain an analytical expression on the surface height difference and a theoretical estimation on the surface fractal dimension. They are preliminarily validated and supported by SPH calculations.
Robledo, Raymond F.; Lambert, Amy J.; Birkenmeier, Connie S.; Cirlan, Marius V.; Cirlan, Andreea Flavia M.; Campagna, Dean R.; Lux, Samuel E.
2010-01-01
Five spontaneous, allelic mutations in the α-spectrin gene, Spna1, have been identified in mice (spherocytosis [sph], sph1J, sph2J, sph2BC, sphDem). All cause severe hemolytic anemia. Here, analysis of 3 new alleles reveals previously unknown consequences of red blood cell (RBC) spectrin deficiency. In sph3J, a missense mutation (H2012Y) in repeat 19 introduces a cryptic splice site resulting in premature termination of translation. In sphIhj, a premature stop codon occurs (Q1853Stop) in repeat 18. Both mutations result in markedly reduced RBC membrane spectrin content, decreased band 3, and absent β-adducin. Reevaluation of available, previously described sph alleles reveals band 3 and adducin deficiency as well. In sph4J, a missense mutation occurs in the C-terminal EF hand domain (C2384Y). Notably, an equally severe hemolytic anemia occurs despite minimally decreased membrane spectrin with normal band 3 levels and present, although reduced, β-adducin. The severity of anemia in sph4J indicates that the highly conserved cysteine residue at the C-terminus of α-spectrin participates in interactions critical to membrane stability. The data reinforce the notion that a membrane bridge in addition to the classic protein 4.1-p55-glycophorin C linkage exists at the RBC junctional complex that involves interactions between spectrin, adducin, and band 3. PMID:20056793
Robledo, Raymond F; Lambert, Amy J; Birkenmeier, Connie S; Cirlan, Marius V; Cirlan, Andreea Flavia M; Campagna, Dean R; Lux, Samuel E; Peters, Luanne L
2010-03-04
Five spontaneous, allelic mutations in the alpha-spectrin gene, Spna1, have been identified in mice (spherocytosis [sph], sph(1J), sph(2J), sph(2BC), sph(Dem)). All cause severe hemolytic anemia. Here, analysis of 3 new alleles reveals previously unknown consequences of red blood cell (RBC) spectrin deficiency. In sph(3J), a missense mutation (H2012Y) in repeat 19 introduces a cryptic splice site resulting in premature termination of translation. In sph(Ihj), a premature stop codon occurs (Q1853Stop) in repeat 18. Both mutations result in markedly reduced RBC membrane spectrin content, decreased band 3, and absent beta-adducin. Reevaluation of available, previously described sph alleles reveals band 3 and adducin deficiency as well. In sph(4J), a missense mutation occurs in the C-terminal EF hand domain (C2384Y). Notably, an equally severe hemolytic anemia occurs despite minimally decreased membrane spectrin with normal band 3 levels and present, although reduced, beta-adducin. The severity of anemia in sph(4J) indicates that the highly conserved cysteine residue at the C-terminus of alpha-spectrin participates in interactions critical to membrane stability. The data reinforce the notion that a membrane bridge in addition to the classic protein 4.1-p55-glycophorin C linkage exists at the RBC junctional complex that involves interactions between spectrin, adducin, and band 3.
Incompressible SPH method for simulating Newtonian and non-Newtonian flows with a free surface
NASA Astrophysics Data System (ADS)
Shao, Songdong; Lo, Edmond Y. M.
An incompressible smoothed particle hydrodynamics (SPH) method is presented to simulate Newtonian and non-Newtonian flows with free surfaces. The basic equations solved are the incompressible mass conservation and Navier-Stokes equations. The method uses prediction-correction fractional steps with the temporal velocity field integrated forward in time without enforcing incompressibility in the prediction step. The resulting deviation of particle density is then implicitly projected onto a divergence-free space to satisfy incompressibility through a pressure Poisson equation derived from an approximate pressure projection. Various SPH formulations are employed in the discretization of the relevant gradient, divergence and Laplacian terms. Free surfaces are identified by the particles whose density is below a set point. Wall boundaries are represented by particles whose positions are fixed. The SPH formulation is also extended to non-Newtonian flows and demonstrated using the Cross rheological model. The incompressible SPH method is tested by typical 2-D dam-break problems in which both water and fluid mud are considered. The computations are in good agreement with available experimental data. The different flow features between Newtonian and non-Newtonian flows after the dam-break are discussed.
Dynamic simulations of geologic materials using combined FEM/DEM/SPH analysis
DOE Office of Scientific and Technical Information (OSTI.GOV)
Morris, J P; Johnson, S M
2008-03-26
An overview of the Lawrence Discrete Element Code (LDEC) is presented, and results from a study investigating the effect of explosive and impact loading on geologic materials using the Livermore Distinct Element Code (LDEC) are detailed. LDEC was initially developed to simulate tunnels and other structures in jointed rock masses using large numbers of polyhedral blocks. Many geophysical applications, such as projectile penetration into rock, concrete targets, and boulder fields, require a combination of continuum and discrete methods in order to predict the formation and interaction of the fragments produced. In an effort to model this class of problems, LDECmore » now includes implementations of Cosserat point theory and cohesive elements. This approach directly simulates the transition from continuum to discontinuum behavior, thereby allowing for dynamic fracture within a combined finite element/discrete element framework. In addition, there are many application involving geologic materials where fluid-structure interaction is important. To facilitate solution of this class of problems a Smooth Particle Hydrodynamics (SPH) capability has been incorporated into LDEC to simulate fully coupled systems involving geologic materials and a saturating fluid. We will present results from a study of a broad range of geomechanical problems that exercise the various components of LDEC in isolation and in tandem.« less
Investigating Darcy-scale assumptions by means of a multiphysics algorithm
NASA Astrophysics Data System (ADS)
Tomin, Pavel; Lunati, Ivan
2016-09-01
Multiphysics (or hybrid) algorithms, which couple Darcy and pore-scale descriptions of flow through porous media in a single numerical framework, are usually employed to decrease the computational cost of full pore-scale simulations or to increase the accuracy of pure Darcy-scale simulations when a simple macroscopic description breaks down. Despite the massive increase in available computational power, the application of these techniques remains limited to core-size problems and upscaling remains crucial for practical large-scale applications. In this context, the Hybrid Multiscale Finite Volume (HMsFV) method, which constructs the macroscopic (Darcy-scale) problem directly by numerical averaging of pore-scale flow, offers not only a flexible framework to efficiently deal with multiphysics problems, but also a tool to investigate the assumptions used to derive macroscopic models and to better understand the relationship between pore-scale quantities and the corresponding macroscale variables. Indeed, by direct comparison of the multiphysics solution with a reference pore-scale simulation, we can assess the validity of the closure assumptions inherent to the multiphysics algorithm and infer the consequences for macroscopic models at the Darcy scale. We show that the definition of the scale ratio based on the geometric properties of the porous medium is well justified only for single-phase flow, whereas in case of unstable multiphase flow the nonlinear interplay between different forces creates complex fluid patterns characterized by new spatial scales, which emerge dynamically and weaken the scale-separation assumption. In general, the multiphysics solution proves very robust even when the characteristic size of the fluid-distribution patterns is comparable with the observation length, provided that all relevant physical processes affecting the fluid distribution are considered. This suggests that macroscopic constitutive relationships (e.g., the relative
StarSmasher: Smoothed Particle Hydrodynamics code for smashing stars and planets
NASA Astrophysics Data System (ADS)
Gaburov, Evghenii; Lombardi, James C., Jr.; Portegies Zwart, Simon; Rasio, F. A.
2018-05-01
Smoothed Particle Hydrodynamics (SPH) is a Lagrangian particle method that approximates a continuous fluid as discrete nodes, each carrying various parameters such as mass, position, velocity, pressure, and temperature. In an SPH simulation the resolution scales with the particle density; StarSmasher is able to handle both equal-mass and equal number-density particle models. StarSmasher solves for hydro forces by calculating the pressure for each particle as a function of the particle's properties - density, internal energy, and internal properties (e.g. temperature and mean molecular weight). The code implements variational equations of motion and libraries to calculate the gravitational forces between particles using direct summation on NVIDIA graphics cards. Using a direct summation instead of a tree-based algorithm for gravity increases the accuracy of the gravity calculations at the cost of speed. The code uses a cubic spline for the smoothing kernel and an artificial viscosity prescription coupled with a Balsara Switch to prevent unphysical interparticle penetration. The code also implements an artificial relaxation force to the equations of motion to add a drag term to the calculated accelerations during relaxation integrations. Initially called StarCrash, StarSmasher was developed originally by Rasio.
NASA Astrophysics Data System (ADS)
Douillet-Grellier, Thomas; Pramanik, Ranjan; Pan, Kai; Albaiz, Abdulaziz; Jones, Bruce D.; Williams, John R.
2017-10-01
This paper develops a method for imposing stress boundary conditions in smoothed particle hydrodynamics (SPH) with and without the need for dummy particles. SPH has been used for simulating phenomena in a number of fields, such as astrophysics and fluid mechanics. More recently, the method has gained traction as a technique for simulation of deformation and fracture in solids, where the meshless property of SPH can be leveraged to represent arbitrary crack paths. Despite this interest, application of boundary conditions within the SPH framework is typically limited to imposed velocity or displacement using fictitious dummy particles to compensate for the lack of particles beyond the boundary interface. While this is enough for a large variety of problems, especially in the case of fluid flow, for problems in solid mechanics there is a clear need to impose stresses upon boundaries. In addition to this, the use of dummy particles to impose a boundary condition is not always suitable or even feasibly, especially for those problems which include internal boundaries. In order to overcome these difficulties, this paper first presents an improved method for applying stress boundary conditions in SPH with dummy particles. This is then followed by a proposal of a formulation which does not require dummy particles. These techniques are then validated against analytical solutions to two common problems in rock mechanics, the Brazilian test and the penny-shaped crack problem both in 2D and 3D. This study highlights the fact that SPH offers a good level of accuracy to solve these problems and that results are reliable. This validation work serves as a foundation for addressing more complex problems involving plasticity and fracture propagation.
SPH with dynamical smoothing length adjustment based on the local flow kinematics
NASA Astrophysics Data System (ADS)
Olejnik, Michał; Szewc, Kamil; Pozorski, Jacek
2017-11-01
Due to the Lagrangian nature of Smoothed Particle Hydrodynamics (SPH), the adaptive resolution remains a challenging task. In this work, we first analyse the influence of the simulation parameters and the smoothing length on solution accuracy, in particular in high strain regions. Based on this analysis we develop a novel approach to dynamically adjust the kernel range for each SPH particle separately, accounting for the local flow kinematics. We use the Okubo-Weiss parameter that distinguishes the strain and vorticity dominated regions in the flow domain. The proposed development is relatively simple and implies only a moderate computational overhead. We validate the modified SPH algorithm for a selection of two-dimensional test cases: the Taylor-Green flow, the vortex spin-down, the lid-driven cavity and the dam-break flow against a sharp-edged obstacle. The simulation results show good agreement with the reference data and improvement of the long-term accuracy for unsteady flows. For the lid-driven cavity case, the proposed dynamical adjustment remedies the problem of tensile instability (particle clustering).
Application of PCDA/SPH/CHO/Lysine vesicles to detect pathogenic bacteria in chicken.
de Oliveira, Taíla V; Soares, Nilda de F F; de Andrade, Nélio J; Silva, Deusanilde J; Medeiros, Eber Antônio A; Badaró, Amanda T
2015-04-01
During the course of infection, Salmonella must successively survive the harsh acid stress of the stomach and multiply into a mild acidic compartment within macrophages. Inducible amino acid decarboxylases are known to promote adaptation to acidic environments, as lysine decarboxylation to cadaverine. The idea of Salmonella defenses responses could be employed in systems as polydiacetylene (PDA) to detect this pathogen so important to public health system. Beside that PDA is an important substance because of the unique optical property; that undergoes a colorimetric transitions by various external stimuli. Therefore 10,12-pentacosadyinoic acid (PCDA)/Sphingomyelin(SPH)/Cholesterol(CHO)/Lysine system was tested to determine the colorimetric response induced by Salmonella choleraesuis. PCDA/SPH/CHO/Lysine vesicles showed a colour change even in low S. choleraesuis concentration present in laboratory conditions and in chicken meat. Thus, this work showed a PCDA/SPH/CHO/Lysine vesicle application to simplify routine analyses in food industry, as chicken meat industry. Copyright © 2014 Elsevier Ltd. All rights reserved.
Theivendran, Shevanuja; Dass, Amala
2017-08-01
Ultrasmall nanomolecules (<2 nm) such as Au 25 (SCH 2 CH 2 Ph) 18 , Au 38 (SCH 2 CH 2 Ph) 24 , and Au 144 (SCH 2 CH 2 Ph) 60 are well studied and can be prepared using established synthetic procedures. No such synthetic protocols that result in high yield products from commercially available starting materials exist for Au 36 (SPh-X) 24 . Here, we report a synthetic procedure for the large-scale synthesis of highly stable Au 36 (SPh-X) 24 with a yield of ∼42%. Au 36 (SPh-X) 24 was conveniently synthesized by using tert-butylbenzenethiol (HSPh-tBu, TBBT) as the ligand, giving a more stable product with better shelf life and higher yield than previously reported for making Au 36 (SPh) 24 from thiophenol (PhSH). The choice of thiol, solvent, and reaction conditions were modified for the optimization of the synthetic procedure. The purposes of this work are to (1) optimize the existing procedure to obtain stable product with better yield, (2) develop a scalable synthetic procedure, (3) demonstrate the superior stability of Au 36 (SPh-tBu) 24 when compared to Au 36 (SPh) 24 , and (4) demonstrate the reproducibility and robustness of the optimized synthetic procedure.
Development of a two-phase SPH model for sediment laden flows
NASA Astrophysics Data System (ADS)
Shi, Huabin; Yu, Xiping; Dalrymple, Robert A.
2017-12-01
A SPH model based on a general formulation for solid-fluid two-phase flows is proposed for suspended sediment motion in free surface flows. The water and the sediment are treated as two miscible fluids, and the multi-fluid system is discretized by a single set of SPH particles, which move with the water velocity and carry properties of the two phases. Large eddy simulation (LES) is introduced to deal with the turbulence effect, and the widely used Smagorinsky model is modified to take into account the influence of sediment particles on the turbulence. The drag force is accurately formulated by including the hindered settling effect. In the model, the water is assumed to be weakly compressible while the sediment is incompressible, and a new equation of state is proposed for the pressure in the sediment-water mixture. Dynamic boundary condition is employed to treat wall boundaries, and a new strategy of Shepard filtering is adopted to damp the pressure oscillation. The developed two-phase SPH model is validated by comparing the numerical results with analytical solutions for idealized cases of still water containing both neutrally buoyant and naturally settling sand and for plane Poiseuille flows carrying neutrally buoyant particles, and is then applied to sand dumping from a line source into a water tank, where the sand cloud settles with a response of the free water surface. It is shown that the numerical results are in good agreement with the experimental data as well as the empirical formulas. The characteristics of the settling sand cloud, the pressure field, and the flow vortices are studied. The motion of the free water surface is also discussed. The proposed two-phase SPH model is proven to be effective for numerical simulation of sand dumping into waters.
Multi-physics simulations of space weather
NASA Astrophysics Data System (ADS)
Gombosi, Tamas; Toth, Gabor; Sokolov, Igor; de Zeeuw, Darren; van der Holst, Bart; Cohen, Ofer; Glocer, Alex; Manchester, Ward, IV; Ridley, Aaron
Presently magnetohydrodynamic (MHD) models represent the "workhorse" technology for simulating the space environment from the solar corona to the ionosphere. While these models are very successful in describing many important phenomena, they are based on a low-order moment approximation of the phase-space distribution function. In the last decade our group at the Center for Space Environment Modeling (CSEM) has developed the Space Weather Modeling Framework (SWMF) that efficiently couples together different models describing the interacting regions of the space environment. Many of these domain models (such as the global solar corona, the inner heliosphere or the global magnetosphere) are based on MHD and are represented by our multiphysics code, BATS-R-US. BATS-R-US can solve the equations of "standard" ideal MHD, but it can also go beyond this first approximation. It can solve resistive MHD, Hall MHD, semi-relativistic MHD (that keeps the displacement current), multispecies (different ion species have different continuity equations) and multifluid (all ion species have separate continuity, momentum and energy equations) MHD. Recently we added two-fluid Hall MHD (solving the electron and ion energy equations separately) and are working on extended magnetohydrodynamics with anisotropic pressures. This talk will show the effects of added physics and compare space weather simulation results to "standard" ideal MHD.
Nimmala, Praneeth Reddy; Knoppe, Stefan; Jupally, Vijay Reddy; Delcamp, Jared H; Aikens, Christine M; Dass, Amala
2014-12-11
The physicochemical properties of gold:thiolate nanomolecules depend on their crystal structure and the capping ligands. The effects of protecting ligands on the crystal structure of the nanomolecules are of high interest in this area of research. Here we report the crystal structure of an all aromatic thiophenolate-capped Au36(SPh)24 nanomolecule, which has a face-centered cubic (fcc) core similar to other nanomolecules such as Au36(SPh-tBu)24 and Au36(SC5H9)24 with the same number of gold atoms and ligands. The results support the idea that a stable core remains intact even when the capping ligand is varied. We also correct our earlier assignment of "Au36(SPh)23" which was determined based on MALDI mass spectrometry which is more prone to fragmentation than ESI mass spectrometry. We show that ESI mass spectrometry gives the correct assignment of Au36(SPh)24, supporting the X-ray crystal structure. The electronic structure of the title compound was computed at different levels of theory (PBE, LDA, and LB94) using the coordinates extracted from the single crystal X-ray diffraction data. The optical and electrochemical properties were determined from experimental data using UV-vis spectroscopy, cyclic voltammetry, and differential pulse voltammetry. Au36(SPh)24 shows a broad electrochemical gap near 2 V, a desirable optical gap of ∼1.75 eV for dye-sensitized solar cell applications, as well as appropriately positioned electrochemical potentials for many electrocatalytic reactions.
A 1D-2D coupled SPH-SWE model applied to open channel flow simulations in complicated geometries
NASA Astrophysics Data System (ADS)
Chang, Kao-Hua; Sheu, Tony Wen-Hann; Chang, Tsang-Jung
2018-05-01
In this study, a one- and two-dimensional (1D-2D) coupled model is developed to solve the shallow water equations (SWEs). The solutions are obtained using a Lagrangian meshless method called smoothed particle hydrodynamics (SPH) to simulate shallow water flows in converging, diverging and curved channels. A buffer zone is introduced to exchange information between the 1D and 2D SPH-SWE models. Interpolated water discharge values and water surface levels at the internal boundaries are prescribed as the inflow/outflow boundary conditions in the two SPH-SWE models. In addition, instead of using the SPH summation operator, we directly solve the continuity equation by introducing a diffusive term to suppress oscillations in the predicted water depth. The performance of the two approaches in calculating the water depth is comprehensively compared through a case study of a straight channel. Additionally, three benchmark cases involving converging, diverging and curved channels are adopted to demonstrate the ability of the proposed 1D and 2D coupled SPH-SWE model through comparisons with measured data and predicted mesh-based numerical results. The proposed model provides satisfactory accuracy and guaranteed convergence.
Variable stars in Local Group Galaxies - II. Sculptor dSph
NASA Astrophysics Data System (ADS)
Martínez-Vázquez, C. E.; Stetson, P. B.; Monelli, M.; Bernard, E. J.; Fiorentino, G.; Gallart, C.; Bono, G.; Cassisi, S.; Dall'Ora, M.; Ferraro, I.; Iannicola, G.; Walker, A. R.
2016-11-01
We present the identification of 634 variable stars in the Milky Way dwarf spheroidal (dSph) satellite Sculptor based on archival ground-based optical observations spanning ˜24 yr and covering ˜2.5 deg2. We employed the same methodologies as the `Homogeneous Photometry' series published by Stetson. In particular, we have identified and characterized one of the largest (536) RR Lyrae samples so far in a Milky Way dSph satellite. We have also detected four Anomalous Cepheids, 23 SX Phoenicis stars, five eclipsing binaries, three field variable stars, three peculiar variable stars located above the horizontal branch - near to the locus of BL Herculis - that we are unable to classify properly. Additionally, we identify 37 long period variables plus 23 probable variable stars, for which the current data do not allow us to determine the period. We report positions and finding charts for all the variable stars, and basic properties (period, amplitude, mean magnitude) and light curves for 574 of them. We discuss the properties of the RR Lyrae stars in the Bailey diagram, which supports the coexistence of subpopulations with different chemical compositions. We estimate the mean mass of Anomalous Cepheids (˜1.5 M⊙) and SX Phoenicis stars (˜1 M⊙). We discuss in detail the nature of the former. The connections between the properties of the different families of variable stars are discussed in the context of the star formation history of the Sculptor dSph galaxy.
General linear methods and friends: Toward efficient solutions of multiphysics problems
NASA Astrophysics Data System (ADS)
Sandu, Adrian
2017-07-01
Time dependent multiphysics partial differential equations are of great practical importance as they model diverse phenomena that appear in mechanical and chemical engineering, aeronautics, astrophysics, meteorology and oceanography, financial modeling, environmental sciences, etc. There is no single best time discretization for the complex multiphysics systems of practical interest. We discuss "multimethod" approaches that combine different time steps and discretizations using the rigourous frameworks provided by Partitioned General Linear Methods and Generalize-structure Additive Runge Kutta Methods..
Oshkin, Igor Y; Miroshnikov, Kirill K; Belova, Svetlana E; Korzhenkov, Aleksei A; Toshchakov, Stepan V; Dedysh, Svetlana N
2018-03-15
Methylovulum psychrotolerans Sph1 T is an aerobic, obligate methanotroph, which was isolated from cold methane seeps in West Siberia. This bacterium possesses only a particulate methane monooxygenase and is widely distributed in low-temperature environments. Strain Sph1 T has the genomic potential for biosynthesis of hopanoids required for the maintenance of intracytoplasmic membranes. Copyright © 2018 Oshkin et al.
Simulating Free Surface Flows with SPH
NASA Astrophysics Data System (ADS)
Monaghan, J. J.
1994-02-01
The SPH (smoothed particle hydrodynamics) method is extended to deal with free surface incompressible flows. The method is easy to use, and examples will be given of its application to a breaking dam, a bore, the simulation of a wave maker, and the propagation of waves towards a beach. Arbitrary moving boundaries can be included by modelling the boundaries by particles which repel the fluid particles. The method is explicit, and the time steps are therefore much shorter than required by other less flexible methods, but it is robust and easy to program.
Ding, Zhili; Kong, Youqin; Chen, Liqiao; Qin, Jianguang; Sun, Shengming; Li, Ming; Du, Zhenyu; Ye, Jinyun
2014-08-01
In this study, a clip-domain serine proteinase homolog designated as MnSPH was cloned and characterized from a freshwater prawn Macrobrachium nipponense. The full-length cDNA of MnSPH was 1897 bp and contained a 1701 bp open reading frame (ORF) encoding a protein of 566 amino acids, a 103 bp 5'-untranslated region, and a 93 bp 3'-untranslated region. Sequence comparison showed that the deduced amino acids of MnSPH shared 30-59% identity with sequences reported in other animals. Tissue distribution analysis indicated that the MnSPH transcripts were present in all detected tissues with highest in the hepatopancreas and ovary. The MnSPH mRNA levels in the developing ovary were stable at the initial three developmental stages, then increased gradually from stage IV (later vitellogenesis), and reached a maximum at stage VI (paracmasis). Furthermore, the expression of MnSPH mRNA in hemocytes was significantly up-regulated at 1.5 h, 6 h, 12 h and 48 h post Aeromonas hydrophila injection. The increased phenoloxidase activity also demonstrated a clear time-dependent pattern after A. hydrophila challenge. These results suggest that MnSPH participates in resisting to pathogenic microorganisms and plays a pivotal role in host defense against microbe invasion in M. nipponense. Copyright © 2014 Elsevier Ltd. All rights reserved.
Dark matter in the Reticulum II dSph: a radio search
NASA Astrophysics Data System (ADS)
Regis, Marco; Richter, Laura; Colafrancesco, Sergio
2017-07-01
We present a deep radio search in the Reticulum II dwarf spheroidal (dSph) galaxy performed with the Australia Telescope Compact Array. Observations were conducted at 16 cm wavelength, with an rms sensitivity of 0.01 mJy/beam, and with the goal of searching for synchrotron emission induced by annihilation or decay of weakly interacting massive particles (WIMPs). Data were complemented with observations on large angular scales taken with the KAT-7 telescope. We find no evidence for a diffuse emission from the dSph and we derive competitive bounds on the WIMP properties. In addition, we detect more than 200 new background radio sources. Among them, we show there are two compelling candidates for being the radio counterpart of the possible γ-ray emission reported by other groups using Fermi-LAT data.
Steel Fibre Reinforced Concrete Simulation with the SPH Method
NASA Astrophysics Data System (ADS)
Hušek, Martin; Kala, Jiří; Král, Petr; Hokeš, Filip
2017-10-01
Steel fibre reinforced concrete (SFRC) is very popular in many branches of civil engineering. Thanks to its increased ductility, it is able to resist various types of loading. When designing a structure, the mechanical behaviour of SFRC can be described by currently available material models (with equivalent material for example) and therefore no problems arise with numerical simulations. But in many scenarios, e.g. high speed loading, it would be a mistake to use such an equivalent material. Physical modelling of the steel fibres used in concrete is usually problematic, though. It is necessary to consider the fact that mesh-based methods are very unsuitable for high-speed simulations with regard to the issues that occur due to the effect of excessive mesh deformation. So-called meshfree methods are much more suitable for this purpose. The Smoothed Particle Hydrodynamics (SPH) method is currently the best choice, thanks to its advantages. However, a numerical defect known as tensile instability may appear when the SPH method is used. It causes the development of numerical (false) cracks, making simulations of ductile types of failure significantly more difficult to perform. The contribution therefore deals with the description of a procedure for avoiding this defect and successfully simulating the behaviour of SFRC with the SPH method. The essence of the problem lies in the choice of coordinates and the description of the integration domain derived from them - spatial (Eulerian kernel) or material coordinates (Lagrangian kernel). The contribution describes the behaviour of both formulations. Conclusions are drawn from the fundamental tasks, and the contribution additionally demonstrates the functionality of SFRC simulations. The random generation of steel fibres and their inclusion in simulations are also discussed. The functionality of the method is supported by the results of pressure test simulations which compare various levels of fibre reinforcement of SFRC
Multiphysics Simulations of Hot-Spot Initiation in Shocked Insensitive High-Explosive
NASA Astrophysics Data System (ADS)
Najjar, Fady; Howard, W. M.; Fried, L. E.
2010-11-01
Solid plastic-bonded high-explosive materials consist of crystals with micron-sized pores embedded. Under mechanical or thermal insults, these voids increase the ease of shock initiation by generating high-temperature regions during their collapse that might lead to ignition. Understanding the mechanisms of hot-spot initiation has significant research interest due to safety, reliability and development of new insensitive munitions. Multi-dimensional high-resolution meso-scale simulations are performed using the multiphysics software, ALE3D, to understand the hot-spot initiation. The Cheetah code is coupled to ALE3D, creating multi-dimensional sparse tables for the HE properties. The reaction rates were obtained from MD Quantum computations. Our current predictions showcase several interesting features regarding hot spot dynamics including the formation of a "secondary" jet. We will discuss the results obtained with hydro-thermo-chemical processes leading to ignition growth for various pore sizes and different shock pressures.
SPH modelling of energy partitioning during impacts on Venus
NASA Technical Reports Server (NTRS)
Takata, T.; Ahrens, T. J.
1993-01-01
Impact cratering of the Venusian planetary surface by meteorites was investigated numerically using the Smoothed Particle Hydrodynamics (SPH) method. Venus presently has a dense atmosphere. Vigorous transfer of energy between impacting meteorites, the planetary surface, and the atmosphere is expected during impact events. The investigation concentrated on the effects of the atmosphere on energy partitioning and the flow of ejecta and gas. The SPH method is particularly suitable for studying complex motion, especially because of its ability to be extended to three dimensions. In our simulations, particles representing impactors and targets are initially set to a uniform density, and those of atmosphere are set to be in hydrostatic equilibrium. Target, impactor, and atmosphere are represented by 9800, 80, and 4200 particles, respectively. A Tillotson equation of state for granite is assumed for the target and impactor, and an ideal gas with constant specific heat ratio is used for the atmosphere. Two dimensional axisymmetric geometry was assumed and normal impacts of 10km diameter projectiles with velocities of 5, 10, 20, and 40 km/s, both with and without an atmosphere present were modeled.
Numerical simulation for the air entrainment of aerated flow with an improved multiphase SPH model
NASA Astrophysics Data System (ADS)
Wan, Hang; Li, Ran; Pu, Xunchi; Zhang, Hongwei; Feng, Jingjie
2017-11-01
Aerated flow is a complex hydraulic phenomenon that exists widely in the field of environmental hydraulics. It is generally characterised by large deformation and violent fragmentation of the free surface. Compared to Euler methods (volume of fluid (VOF) method or rigid-lid hypothesis method), the existing single-phase Smooth Particle Hydrodynamics (SPH) method has performed well for solving particle motion. A lack of research on interphase interaction and air concentration, however, has affected the application of SPH model. In our study, an improved multiphase SPH model is presented to simulate aeration flows. A drag force was included in the momentum equation to ensure accuracy of the air particle slip velocity. Furthermore, a calculation method for air concentration is developed to analyse the air entrainment characteristics. Two studies were used to simulate the hydraulic and air entrainment characteristics. And, compared with the experimental results, the simulation results agree with the experimental results well.
Dark matter in the Reticulum II dSph: a radio search
DOE Office of Scientific and Technical Information (OSTI.GOV)
Regis, Marco; Richter, Laura; Colafrancesco, Sergio, E-mail: regis@to.infn.it, E-mail: llrichter@gmail.com, E-mail: sergio.colafrancesco@wits.ac.za
2017-07-01
We present a deep radio search in the Reticulum II dwarf spheroidal (dSph) galaxy performed with the Australia Telescope Compact Array. Observations were conducted at 16 cm wavelength, with an rms sensitivity of 0.01 mJy/beam, and with the goal of searching for synchrotron emission induced by annihilation or decay of weakly interacting massive particles (WIMPs). Data were complemented with observations on large angular scales taken with the KAT-7 telescope. We find no evidence for a diffuse emission from the dSph and we derive competitive bounds on the WIMP properties. In addition, we detect more than 200 new background radio sources.more » Among them, we show there are two compelling candidates for being the radio counterpart of the possible γ-ray emission reported by other groups using Fermi-LAT data.« less
Multiphysics superensemble forecast applied to Mediterranean heavy precipitation situations
NASA Astrophysics Data System (ADS)
Vich, M.; Romero, R.
2010-11-01
The high-impact precipitation events that regularly affect the western Mediterranean coastal regions are still difficult to predict with the current prediction systems. Bearing this in mind, this paper focuses on the superensemble technique applied to the precipitation field. Encouraged by the skill shown by a previous multiphysics ensemble prediction system applied to western Mediterranean precipitation events, the superensemble is fed with this ensemble. The training phase of the superensemble contributes to the actual forecast with weights obtained by comparing the past performance of the ensemble members and the corresponding observed states. The non-hydrostatic MM5 mesoscale model is used to run the multiphysics ensemble. Simulations are performed with a 22.5 km resolution domain (Domain 1 in http://mm5forecasts.uib.es) nested in the ECMWF forecast fields. The period between September and December 2001 is used to train the superensemble and a collection of 19~MEDEX cyclones is used to test it. The verification procedure involves testing the superensemble performance and comparing it with that of the poor-man and bias-corrected ensemble mean and the multiphysic EPS control member. The results emphasize the need of a well-behaved training phase to obtain good results with the superensemble technique. A strategy to obtain this improved training phase is already outlined.
Coupling between a multi-physics workflow engine and an optimization framework
NASA Astrophysics Data System (ADS)
Di Gallo, L.; Reux, C.; Imbeaux, F.; Artaud, J.-F.; Owsiak, M.; Saoutic, B.; Aiello, G.; Bernardi, P.; Ciraolo, G.; Bucalossi, J.; Duchateau, J.-L.; Fausser, C.; Galassi, D.; Hertout, P.; Jaboulay, J.-C.; Li-Puma, A.; Zani, L.
2016-03-01
A generic coupling method between a multi-physics workflow engine and an optimization framework is presented in this paper. The coupling architecture has been developed in order to preserve the integrity of the two frameworks. The objective is to provide the possibility to replace a framework, a workflow or an optimizer by another one without changing the whole coupling procedure or modifying the main content in each framework. The coupling is achieved by using a socket-based communication library for exchanging data between the two frameworks. Among a number of algorithms provided by optimization frameworks, Genetic Algorithms (GAs) have demonstrated their efficiency on single and multiple criteria optimization. Additionally to their robustness, GAs can handle non-valid data which may appear during the optimization. Consequently GAs work on most general cases. A parallelized framework has been developed to reduce the time spent for optimizations and evaluation of large samples. A test has shown a good scaling efficiency of this parallelized framework. This coupling method has been applied to the case of SYCOMORE (SYstem COde for MOdeling tokamak REactor) which is a system code developed in form of a modular workflow for designing magnetic fusion reactors. The coupling of SYCOMORE with the optimization platform URANIE enables design optimization along various figures of merit and constraints.
Experimental Evaluation of Acoustic Engine Liner Models Developed with COMSOL Multiphysics
NASA Technical Reports Server (NTRS)
Schiller, Noah H.; Jones, Michael G.; Bertolucci, Brandon
2017-01-01
Accurate modeling tools are needed to design new engine liners capable of reducing aircraft noise. The purpose of this study is to determine if a commercially-available finite element package, COMSOL Multiphysics, can be used to accurately model a range of different acoustic engine liner designs, and in the process, collect and document a benchmark dataset that can be used in both current and future code evaluation activities. To achieve these goals, a variety of liner samples, ranging from conventional perforate-over-honeycomb to extended-reaction designs, were installed in one wall of the grazing flow impedance tube at the NASA Langley Research Center. The liners were exposed to high sound pressure levels and grazing flow, and the effect of the liner on the sound field in the flow duct was measured. These measurements were then compared with predictions. While this report only includes comparisons for a subset of the configurations, the full database of all measurements and predictions is available in electronic format upon request. The results demonstrate that both conventional perforate-over-honeycomb and extended-reaction liners can be accurately modeled using COMSOL. Therefore, this modeling tool can be used with confidence to supplement the current suite of acoustic propagation codes, and ultimately develop new acoustic engine liners designed to reduce aircraft noise.
NASA Astrophysics Data System (ADS)
Feltzing, S.; Eriksson, K.; Kleyna, J.; Wilkinson, M. I.
2009-12-01
Aims. We establish the mean metallicity from high-resolution spectroscopy for the recently found dwarf spheroidal galaxy Boötes I and test whether it is a common feature for ultra-faint dwarf spheroidal galaxies to show signs of inhomogeneous chemical evolution (e.g. as found in the Hercules dwarf spheroidal galaxy). Methods: We analyse high-resolution, moderate signal-to-noise spectra for seven red giant stars in the Boötes I dSph galaxy using standard abundance analysis techniques. In particular, we assume local thermodynamic equilibrium and employ spherical model atmospheres and codes that take the sphericity of the star into account when calculating the elemental abundances. Results: We confirm previous determinations of the mean metallicity of the Boötes I dwarf spheroidal galaxy to be -2.3 dex. Whilst five stars are clustered around this metallicity, one is significantly more metal-poor, at -2.9 dex, and one is more metal-rich at, -1.9 dex. Additionally, we find that one of the stars, Boo-127, shows an atypically high [Mg/Ca] ratio, indicative of stochastic enrichment processes within the dSph galaxy. Similar results have previously only been found in the Hercules and Draco dSph galaxies and appear, so far, to be unique to this type of galaxy. The data presented herein were obtained at the W.M. Keck Observatory, which is operated as a scientific partnership among the California Institute of Technology, the University of California and the National Aeronautics and Space Administration. The Observatory was made possible by the generous financial support of the W.M. Keck Foundation.
Divergence-Free SPH for Incompressible and Viscous Fluids.
Bender, Jan; Koschier, Dan
2017-03-01
In this paper we present a novel Smoothed Particle Hydrodynamics (SPH) method for the efficient and stable simulation of incompressible fluids. The most efficient SPH-based approaches enforce incompressibility either on position or velocity level. However, the continuity equation for incompressible flow demands to maintain a constant density and a divergence-free velocity field. We propose a combination of two novel implicit pressure solvers enforcing both a low volume compression as well as a divergence-free velocity field. While a compression-free fluid is essential for realistic physical behavior, a divergence-free velocity field drastically reduces the number of required solver iterations and increases the stability of the simulation significantly. Thanks to the improved stability, our method can handle larger time steps than previous approaches. This results in a substantial performance gain since the computationally expensive neighborhood search has to be performed less frequently. Moreover, we introduce a third optional implicit solver to simulate highly viscous fluids which seamlessly integrates into our solver framework. Our implicit viscosity solver produces realistic results while introducing almost no numerical damping. We demonstrate the efficiency, robustness and scalability of our method in a variety of complex simulations including scenarios with millions of turbulent particles or highly viscous materials.
SPH modeling and simulation of spherical particles interacting in a viscoelastic matrix
NASA Astrophysics Data System (ADS)
Vázquez-Quesada, A.; Ellero, M.
2017-12-01
In this work, we extend the three-dimensional Smoothed Particle Hydrodynamics (SPH) non-colloidal particulate model previously developed for Newtonian suspending media in Vázquez-Quesada and Ellero ["Rheology and microstructure of non-colloidal suspensions under shear studied with smoothed particle hydrodynamics," J. Non-Newtonian Fluid Mech. 233, 37-47 (2016)] to viscoelastic matrices. For the solvent medium, the coarse-grained SPH viscoelastic formulation proposed in Vázquez-Quesada, Ellero, and Español ["Smoothed particle hydrodynamic model for viscoelastic fluids with thermal fluctuations," Phys. Rev. E 79, 056707 (2009)] is adopted. The property of this particular set of equations is that they are entirely derived within the general equation for non-equilibrium reversible-irreversible coupling formalism and therefore enjoy automatically thermodynamic consistency. The viscoelastic model is derived through a physical specification of a conformation-tensor-dependent entropy function for the fluid particles. In the simple case of suspended Hookean dumbbells, this delivers a specific SPH discretization of the Oldroyd-B constitutive equation. We validate the suspended particle model by studying the dynamics of single and mutually interacting "noncolloidal" rigid spheres under shear flow and in the presence of confinement. Numerical results agree well with available numerical and experimental data. It is straightforward to extend the particulate model to Brownian conditions and to more complex viscoelastic solvents.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Wetzstein, M.; Nelson, Andrew F.; Naab, T.
2009-10-01
We present a numerical code for simulating the evolution of astrophysical systems using particles to represent the underlying fluid flow. The code is written in Fortran 95 and is designed to be versatile, flexible, and extensible, with modular options that can be selected either at the time the code is compiled or at run time through a text input file. We include a number of general purpose modules describing a variety of physical processes commonly required in the astrophysical community and we expect that the effort required to integrate additional or alternate modules into the code will be small. Inmore » its simplest form the code can evolve the dynamical trajectories of a set of particles in two or three dimensions using a module which implements either a Leapfrog or Runge-Kutta-Fehlberg integrator, selected by the user at compile time. The user may choose to allow the integrator to evolve the system using individual time steps for each particle or with a single, global time step for all. Particles may interact gravitationally as N-body particles, and all or any subset may also interact hydrodynamically, using the smoothed particle hydrodynamic (SPH) method by selecting the SPH module. A third particle species can be included with a module to model massive point particles which may accrete nearby SPH or N-body particles. Such particles may be used to model, e.g., stars in a molecular cloud. Free boundary conditions are implemented by default, and a module may be selected to include periodic boundary conditions. We use a binary 'Press' tree to organize particles for rapid access in gravity and SPH calculations. Modules implementing an interface with special purpose 'GRAPE' hardware may also be selected to accelerate the gravity calculations. If available, forces obtained from the GRAPE coprocessors may be transparently substituted for those obtained from the tree, or both tree and GRAPE may be used as a combination GRAPE/tree code. The code may be run without
NASA Astrophysics Data System (ADS)
Wetzstein, M.; Nelson, Andrew F.; Naab, T.; Burkert, A.
2009-10-01
We present a numerical code for simulating the evolution of astrophysical systems using particles to represent the underlying fluid flow. The code is written in Fortran 95 and is designed to be versatile, flexible, and extensible, with modular options that can be selected either at the time the code is compiled or at run time through a text input file. We include a number of general purpose modules describing a variety of physical processes commonly required in the astrophysical community and we expect that the effort required to integrate additional or alternate modules into the code will be small. In its simplest form the code can evolve the dynamical trajectories of a set of particles in two or three dimensions using a module which implements either a Leapfrog or Runge-Kutta-Fehlberg integrator, selected by the user at compile time. The user may choose to allow the integrator to evolve the system using individual time steps for each particle or with a single, global time step for all. Particles may interact gravitationally as N-body particles, and all or any subset may also interact hydrodynamically, using the smoothed particle hydrodynamic (SPH) method by selecting the SPH module. A third particle species can be included with a module to model massive point particles which may accrete nearby SPH or N-body particles. Such particles may be used to model, e.g., stars in a molecular cloud. Free boundary conditions are implemented by default, and a module may be selected to include periodic boundary conditions. We use a binary "Press" tree to organize particles for rapid access in gravity and SPH calculations. Modules implementing an interface with special purpose "GRAPE" hardware may also be selected to accelerate the gravity calculations. If available, forces obtained from the GRAPE coprocessors may be transparently substituted for those obtained from the tree, or both tree and GRAPE may be used as a combination GRAPE/tree code. The code may be run without
NASA Astrophysics Data System (ADS)
Zubeldia, Elizabeth H.; Fourtakas, Georgios; Rogers, Benedict D.; Farias, Márcio M.
2018-07-01
A two-phase numerical model using Smoothed Particle Hydrodynamics (SPH) is developed to model the scouring of two-phase liquid-sediments flows with large deformation. The rheology of sediment scouring due to flows with slow kinematics and high shear forces presents a challenge in terms of spurious numerical fluctuations. This paper bridges the gap between the non-Newtonian and Newtonian flows by proposing a model that combines the yielding, shear and suspension layer mechanics which are needed to predict accurately the local erosion phenomena. A critical bed-mobility condition based on the Shields criterion is imposed to the particles located at the sediment surface. Thus, the onset of the erosion process is independent on the pressure field and eliminates the numerical problem of pressure dependant erosion at the interface. This is combined with the Drucker-Prager yield criterion to predict the onset of yielding of the sediment surface and a concentration suspension model. The multi-phase model has been implemented in the open-source DualSPHysics code accelerated with a graphics processing unit (GPU). The multi-phase model has been compared with 2-D reference numerical models and new experimental data for scour with convergent results. Numerical results for a dry-bed dam break over an erodible bed shows improved agreement with experimental scour and water surface profiles compared to well-known SPH multi-phase models.
Multicale modeling of the detonation of aluminized explosives using SPH-MD-QM method
NASA Astrophysics Data System (ADS)
Peng, Qing; Wang, Guangyu; Liu, Gui-Rong; de, Suvranu
Aluminized explosives have been applied in military industry since decades ago. Compared with ideal explosives, aluminized explosives feature both fast detonation and slow metal combustion chemistry, generating a complex multi-phase reactive flow. Here, we introduce a sequential multiscale model of SPH-MD-QM to simulate the detonation behavior of aluminized explosives. At the bottom level, first-principles quantum mechanics (QM) calculations are employed to obtain the training sets for fitting the ReaxFF potentials, which are used in turn in the reactive molecular dynamics (MD) simulations in the middle level to obtain the chemical reaction rates and equations of states. At the up lever, a smooth particle hydrodynamics (SPH) method incorporated ignition and growth model and afterburning model has been used for the simulation of the detonation and combustion of the aluminized explosive. Simulation is compared with experiment and good agreement is observed. The proposed multiscale method of SPH-MD-QM could be used to optimize the performance of aluminized explosives. The authors would like to acknowledge the generous financial support from the Defense Threat Reduction Agency (DTRA) Grant No. HDTRA1-13-1-0025 and the Office of Naval Research Grants ONR Award No. N00014-08-1-0462 and No. N00014-12-1-0527.
NASA Astrophysics Data System (ADS)
Ševecek, Pavel; Broz, Miroslav; Nesvorny, David; Durda, Daniel D.; Asphaug, Erik; Walsh, Kevin J.; Richardson, Derek C.
2016-10-01
Detailed models of asteroid collisions can yield important constrains for the evolution of the Main Asteroid Belt, but the respective parameter space is large and often unexplored. We thus performed a new set of simulations of asteroidal breakups, i.e. fragmentations of intact targets, subsequent gravitational reaccumulation and formation of small asteroid families, focusing on parent bodies with diameters D = 10 km.Simulations were performed with a smoothed-particle hydrodynamics (SPH) code (Benz & Asphaug 1994), combined with an efficient N-body integrator (Richardson et al. 2000). We assumed a number of projectile sizes, impact velocities and impact angles. The rheology used in the physical model does not include friction nor crushing; this allows for a direct comparison to results of Durda et al. (2007). Resulting size-frequency distributions are significantly different from scaled-down simulations with D = 100 km monolithic targets, although they may be even more different for pre-shattered targets.We derive new parametric relations describing fragment distributions, suitable for Monte-Carlo collisional models. We also characterize velocity fields and angular distributions of fragments, which can be used as initial conditions in N-body simulations of small asteroid families. Finally, we discuss various uncertainties related to SPH simulations.
NASA Astrophysics Data System (ADS)
Bellazzini, M.; Ferraro, F. R.; Buonanno, R.
1999-01-01
We present the first results of a large photometric survey devoted to the study of the star formation history in the Sagittarius dwarf spheroidal galaxy (Sgr dSph). Three large (size: 9 x 35 arcmin2) and widely spaced fields located nearly along the Sgr dSph major axis [(l,b) = (6.5 -16);(6-14);(5-12)] have been observed in the V and I passbands with the ESO-NTT 3.5-m telescope (La Silla - Chile). Well-calibrated photometry has been obtained for ˜90000 stars toward Sgr dSph and for ˜9000 stars in a (9 x 24 arcmin2) control field down to a limiting magnitude of V 22. At present this is the largest photometric (CCD) sample of Sgr dSph stars and the wide spacing between field provides the first opportunity of studying the stellar content of different regions of the galaxy (over a range of ˜2 Kpc across). Age and metallicity estimates are obtained for the detected stellar populations and the very first evidences are presented for (a) spatial differences in the stellar content and (b) the detection of a very metal poor population in the field of the Sgr galaxy.
NASA Astrophysics Data System (ADS)
Vela Vela, Luis; Sanchez, Raul; Geiger, Joachim
2018-03-01
A method is presented to obtain initial conditions for Smoothed Particle Hydrodynamic (SPH) scenarios where arbitrarily complex density distributions and low particle noise are needed. Our method, named ALARIC, tampers with the evolution of the internal variables to obtain a fast and efficient profile evolution towards the desired goal. The result has very low levels of particle noise and constitutes a perfect candidate to study the equilibrium and stability properties of SPH/SPMHD systems. The method uses the iso-thermal SPH equations to calculate hydrodynamical forces under the presence of an external fictitious potential and evolves them in time with a 2nd-order symplectic integrator. The proposed method generates tailored initial conditions that perform better in many cases than those based on purely crystalline lattices, since it prevents the appearance of anisotropies.
High-fidelity plasma codes for burn physics
DOE Office of Scientific and Technical Information (OSTI.GOV)
Cooley, James; Graziani, Frank; Marinak, Marty
Accurate predictions of equation of state (EOS), ionic and electronic transport properties are of critical importance for high-energy-density plasma science. Transport coefficients inform radiation-hydrodynamic codes and impact diagnostic interpretation, which in turn impacts our understanding of the development of instabilities, the overall energy balance of burning plasmas, and the efficacy of self-heating from charged-particle stopping. Important processes include thermal and electrical conduction, electron-ion coupling, inter-diffusion, ion viscosity, and charged particle stopping. However, uncertainties in these coefficients are not well established. Fundamental plasma science codes, also called high-fidelity plasma codes, are a relatively recent computational tool that augments both experimental datamore » and theoretical foundations of transport coefficients. This paper addresses the current status of HFPC codes and their future development, and the potential impact they play in improving the predictive capability of the multi-physics hydrodynamic codes used in HED design.« less
Co-assembly of Zn(SPh){sub 2} and organic linkers into helical and zig-zag polymer chains
DOE Office of Scientific and Technical Information (OSTI.GOV)
Liu Yi; Yu Lingmin; Loo, Say Chye Joachim
2012-07-15
Two novel one-dimensional coordination polymers, single helicate [Zn(SPh){sub 2}(TPyTA)(EG)]{sub n} (EG=ethylene glycol) (1) and zig-zag structure [Zn(SPh){sub 2}(BPyVB)]{sub n} (2), were synthesized under solvothermal conditions at 150 Degree-Sign C or room temperature by the co-assembly of Zn(SPh){sub 2} and organic linkers such as 2,4,6-tri(4-pyridyl)-1,3,5-triazine (TPyTA) and 1,3-bis(trans-4-pyridylvinyl)benzene (BPyVB). X-ray crystallography study reveals that both polymers 1 and 2 crystallize in space group P2{sub 1}/c of the monoclinic system. The solid-state UV-vis absorption spectra show that 1 and 2 have maxium absorption onsets at 400 nm and 420 nm, respectively. TGA analysis indicates that 1 and 2 are stable up tomore » 110 Degree-Sign C and 210 Degree-Sign C. - Graphical abstract: Two novel one-dimensional coordination polymers, single helicate [Zn(SPh){sub 2}(TPyTA)(EG)]{sub n} (1) and zig-zag structure [Zn(SPh){sub 2}(BPyVB)]{sub n} (2), were synthesized. Solid-state UV-vis absorptions show that 1 and 2 have maxium absorption onsets at 400 nm and 420 nm, respectively. TGA analysis indicates that 1 and 2 are stable up to 110 Degree-Sign C and 210 Degree-Sign C. Highlights: Black-Right-Pointing-Pointer Two novel one-dimensional coordination polymers have been synthesized. Black-Right-Pointing-Pointer TPyTA results in helical structures in 1 while BPyVB leads to zig-zag chains in 2. Black-Right-Pointing-Pointer Solid-state UV-vis absorption spectra and TGA analysis of the title polymers were studied.« less
General Relativistic Smoothed Particle Hydrodynamics code developments: A progress report
NASA Astrophysics Data System (ADS)
Faber, Joshua; Silberman, Zachary; Rizzo, Monica
2017-01-01
We report on our progress in developing a new general relativistic Smoothed Particle Hydrodynamics (SPH) code, which will be appropriate for studying the properties of accretion disks around black holes as well as compact object binary mergers and their ejecta. We will discuss in turn the relativistic formalisms being used to handle the evolution, our techniques for dealing with conservative and primitive variables, as well as those used to ensure proper conservation of various physical quantities. Code tests and performance metrics will be discussed, as will the prospects for including smoothed particle hydrodynamics codes within other numerical relativity codebases, particularly the publicly available Einstein Toolkit. We acknowledge support from NSF award ACI-1550436 and an internal RIT D-RIG grant.
SphK1 inhibitor II (SKI-II) inhibits acute myelogenous leukemia cell growth in vitro and in vivo
DOE Office of Scientific and Technical Information (OSTI.GOV)
Yang, Li; Weng, Wei; Sun, Zhi-Xin
Previous studies have identified sphingosine kinase 1 (SphK1) as a potential drug target for treatment of acute myeloid leukemia (AML). In the current study, we investigated the potential anti-leukemic activity of a novel and specific SphK1 inhibitor, SKI-II. We demonstrated that SKI-II inhibited growth and survival of human AML cell lines (HL-60 and U937 cells). SKI-II was more efficient than two known SphK1 inhibitors SK1-I and FTY720 in inhibiting AML cells. Meanwhile, it induced dramatic apoptosis in above AML cells, and the cytotoxicity by SKI-II was almost reversed by the general caspase inhibitor z-VAD-fmk. SKI-II treatment inhibited SphK1 activation, andmore » concomitantly increased level of sphingosine-1-phosphate (S1P) precursor ceramide in AML cells. Conversely, exogenously-added S1P protected against SKI-II-induced cytotoxicity, while cell permeable short-chain ceramide (C6) aggravated SKI-II's lethality against AML cells. Notably, SKI-II induced potent apoptotic death in primary human AML cells, but was generally safe to the human peripheral blood mononuclear cells (PBMCs) isolated from healthy donors. In vivo, SKI-II administration suppressed growth of U937 leukemic xenograft tumors in severe combined immunodeficient (SCID) mice. These results suggest that SKI-II might be further investigated as a promising anti-AML agent. - Highlights: • SKI-II inhibits proliferation and survival of primary and transformed AML cells. • SKI-II induces apoptotic death of AML cells, but is safe to normal PBMCs. • SKI-II is more efficient than two known SphK1 inhibitors in inhibiting AML cells. • SKI-II inhibits SphK1 activity, while increasing ceramide production in AML cells. • SKI-II dose-dependently inhibits U937 xenograft growth in SCID mice.« less
A 3-D SPH model for simulating water flooding of a damaged floating structure
NASA Astrophysics Data System (ADS)
Guo, Kai; Sun, Peng-nan; Cao, Xue-yan; Huang, Xiao
2017-10-01
With the quasi-static analysis method, the terminal floating state of a damaged ship is usually evaluated for the risk assessment. But this is not enough since the ship has the possibility to lose its stability during the transient flooding process. Therefore, an enhanced smoothed particle hydrodynamics (SPH) model is applied in this paper to investigate the response of a simplified cabin model under the condition of the transient water flooding. The enhanced SPH model is presented firstly including the governing equations, the diffusive terms, the boundary implementations and then an algorithm regarding the coupling motions of six degrees of freedom (6-DOF) between the structure and the fluid is described. In the numerical results, a non-damaged cabin floating under the rest condition is simulated. It is shown that a stable floating state can be reached and maintained by using the present SPH scheme. After that, three-dimensional (3-D) test cases of the damaged cabin with a hole at different locations are simulated. A series of model tests are also carried out for the validation. Fairly good agreements are achieved between the numerical results and the experimental data. Relevant conclusions are drawn with respect to the mechanism of the responses of the damaged cabin model under water flooding conditions.
An arbitrary boundary with ghost particles incorporated in coupled FEM-SPH model for FSI problems
NASA Astrophysics Data System (ADS)
Long, Ting; Hu, Dean; Wan, Detao; Zhuang, Chen; Yang, Gang
2017-12-01
It is important to treat the arbitrary boundary of Fluid-Structure Interaction (FSI) problems in computational mechanics. In order to ensure complete support condition and restore the first-order consistency near the boundary of Smoothed Particle Hydrodynamics (SPH) method for coupling Finite Element Method (FEM) with SPH model, a new ghost particle method is proposed by dividing the interceptive area of kernel support domain into subareas corresponding to boundary segments of structure. The ghost particles are produced automatically for every fluid particle at each time step, and the properties of ghost particles, such as density, mass and velocity, are defined by using the subareas to satisfy the boundary condition. In the coupled FEM-SPH model, the normal and shear forces from a boundary segment of structure to a fluid particle are calculated through the corresponding ghost particles, and its opposite forces are exerted on the corresponding boundary segment, then the momentum of the present method is conservation and there is no matching requirements between the size of elements and the size of particles. The performance of the present method is discussed and validated by several FSI problems with complex geometry boundary and moving boundary.
An Object-Oriented Finite Element Framework for Multiphysics Phase Field Simulations
DOE Office of Scientific and Technical Information (OSTI.GOV)
Michael R Tonks; Derek R Gaston; Paul C Millett
2012-01-01
The phase field approach is a powerful and popular method for modeling microstructure evolution. In this work, advanced numerical tools are used to create a phase field framework that facilitates rapid model development. This framework, called MARMOT, is based on Idaho National Laboratory's finite element Multiphysics Object-Oriented Simulation Environment. In MARMOT, the system of phase field partial differential equations (PDEs) are solved simultaneously with PDEs describing additional physics, such as solid mechanics and heat conduction, using the Jacobian-Free Newton Krylov Method. An object-oriented architecture is created by taking advantage of commonalities in phase fields models to facilitate development of newmore » models with very little written code. In addition, MARMOT provides access to mesh and time step adaptivity, reducing the cost for performing simulations with large disparities in both spatial and temporal scales. In this work, phase separation simulations are used to show the numerical performance of MARMOT. Deformation-induced grain growth and void growth simulations are included to demonstrate the muliphysics capability.« less
Verification of a Multiphysics Toolkit against the Magnetized Target Fusion Concept
NASA Technical Reports Server (NTRS)
Thomas, Scott; Perrell, Eric; Liron, Caroline; Chiroux, Robert; Cassibry, Jason; Adams, Robert B.
2005-01-01
In the spring of 2004 the Advanced Concepts team at MSFC embarked on an ambitious project to develop a suite of modeling routines that would interact with one another. The tools would each numerically model a portion of any advanced propulsion system. The tools were divided by physics categories, hence the name multiphysics toolset. Currently most of the anticipated modeling tools have been created and integrated. Results are given in this paper for both a quarter nozzle with chemically reacting flow and the interaction of two plasma jets representative of a Magnetized Target Fusion device. The results have not been calibrated against real data as of yet, but this paper demonstrates the current capability of the multiphysics tool and planned future enhancements
NASA Astrophysics Data System (ADS)
Sandalski, Stou
Smooth particle hydrodynamics is an efficient method for modeling the dynamics of fluids. It is commonly used to simulate astrophysical processes such as binary mergers. We present a newly developed GPU accelerated smooth particle hydrodynamics code for astrophysical simulations. The code is named 
SPH simulation of free surface flow over a sharp-crested weir
NASA Astrophysics Data System (ADS)
Ferrari, Angela
2010-03-01
In this paper the numerical simulation of a free surface flow over a sharp-crested weir is presented. Since in this case the usual shallow water assumptions are not satisfied, we propose to solve the problem using the full weakly compressible Navier-Stokes equations with the Tait equation of state for water. The numerical method used consists of the new meshless Smooth Particle Hydrodynamics (SPH) formulation proposed by Ferrari et al. (2009) [8], that accurately tracks the free surface profile and provides monotone pressure fields. Thus, the unsteady evolution of the complex moving material interface (free surface) can been properly solved. The simulations involving about half a million of fluid particles have been run in parallel on two of the most powerful High Performance Computing (HPC) facilities in Europe. The validation of the results has been carried out analysing the pressure field and comparing the free surface profiles obtained with the SPH scheme with experimental measurements available in literature [18]. A very good quantitative agreement has been obtained.
Prescribed Velocity Gradients for Highly Viscous SPH Fluids with Vorticity Diffusion.
Peer, Andreas; Teschner, Matthias
2017-12-01
Working with prescribed velocity gradients is a promising approach to efficiently and robustly simulate highly viscous SPH fluids. Such approaches allow to explicitly and independently process shear rate, spin, and expansion rate. This can be used to, e.g., avoid interferences between pressure and viscosity solvers. Another interesting aspect is the possibility to explicitly process the vorticity, e.g., to preserve the vorticity. In this context, this paper proposes a novel variant of the prescribed-gradient idea that handles vorticity in a physically motivated way. In contrast to a less appropriate vorticity preservation that has been used in a previous approach, vorticity is diffused. The paper illustrates the utility of the vorticity diffusion. Therefore, comparisons of the proposed vorticity diffusion with vorticity preservation and additionally with vorticity damping are presented. The paper further discusses the relation between prescribed velocity gradients and prescribed velocity Laplacians which improves the intuition behind the prescribed-gradient method for highly viscous SPH fluids. Finally, the paper discusses the relation of the proposed method to a physically correct implicit viscosity formulation.
M3Ag17(SPh)12 Nanoparticles and Their Structure Prediction.
Wickramasinghe, Sameera; Atnagulov, Aydar; Conn, Brian E; Yoon, Bokwon; Barnett, Robert N; Griffith, Wendell P; Landman, Uzi; Bigioni, Terry P
2015-09-16
Although silver nanoparticles are of great fundamental and practical interest, only one structure has been determined thus far: M4Ag44(SPh)30, where M is a monocation, and SPh is an aromatic thiolate ligand. This is in part due to the fact that no other molecular silver nanoparticles have been synthesized with aromatic thiolate ligands. Here we report the synthesis of M3Ag17(4-tert-butylbenzene-thiol)12, which has good stability and an unusual optical spectrum. We also present a rational strategy for predicting the structure of this molecule. First-principles calculations support the structural model, predict a HOMO-LUMO energy gap of 1.77 eV, and predict a new "monomer mount" capping motif, Ag(SR)3, for Ag nanoparticles. The calculated optical absorption spectrum is in good correspondence with the measured spectrum. Heteroatom substitution was also used as a structural probe. First-principles calculations based on the structural model predicted a strong preference for a single Au atom substitution in agreement with experiment.
Bertz, Steven H; Hardin, Richard A; Heavey, Thomas J; Jones, Daniel S; Monroe, T Blake; Murphy, Michael D; Ogle, Craig A; Whaley, Tara N
2013-07-29
Grow slow: The usual direct treatment of MeLi and CuSPh did not yield X-ray quality crystals of MeCu(SPh)Li. An indirect method starting from Me2CuLi⋅LiSPh and chalcone afforded the desired crystals by the slow reaction of the intermediate π-complex (see scheme). This strategy produced the first X-ray crystal structure of a Posner cuprate. A complementary NMR study showed that the contact ion pair was also the main species in solution. Copyright © 2013 WILEY-VCH Verlag GmbH & Co. KGaA, Weinheim.
A Multi-physics Approach to Understanding Low Porosity Soils and Reservoir Rocks
NASA Astrophysics Data System (ADS)
Prasad, M.; Mapeli, C.; Livo, K.; Hasanov, A.; Schindler, M.; Ou, L.
2017-12-01
We present recent results on our multiphysics approach to rock physics. Thus, we evaluate geophysical measurements by simultaneously measuring petrophysical properties or imaging strains. In this paper, we present simultaneously measured acoustic and electrical anisotropy data as functions of pressure. Similarly, we present strains and strain localization images simultaneously acquired with acoustic measurements as well as NMR T2 relaxations on pressurized fluids as well as rocks saturated with these pressurized fluids. Such multiphysics experiments allow us to constrain and assign appropriate causative mechanisms to development rock physics models. They also allow us to decouple various effects, for example, fluid versus pressure, on geophysical measurements. We show applications towards reservoir characterization as well as CO2 sequestration applications.
Xia, Yidong; Podgorney, Robert; Huang, Hai
2016-03-17
FALCON (“Fracturing And Liquid CONvection”) is a hybrid continuous / discontinuous Galerkin finite element geothermal reservoir simulation code based on the MOOSE (“Multiphysics Object-Oriented Simulation Environment”) framework being developed and used for multiphysics applications. In the present work, a suite of verification and validation (“V&V”) test problems for FALCON was defined to meet the design requirements, and solved to the interests of enhanced geothermal system (“EGS”) design. Furthermore, the intent for this test problem suite is to provide baseline comparison data that demonstrates the performance of the FALCON solution methods. The simulation problems vary in complexity from singly mechanical ormore » thermo process, to coupled thermo-hydro-mechanical processes in geological porous media. Numerical results obtained by FALCON agreed well with either the available analytical solution or experimental data, indicating the verified and validated implementation of these capabilities in FALCON. Some form of solution verification has been attempted to identify sensitivities in the solution methods, where possible, and suggest best practices when using the FALCON code.« less
NASA Astrophysics Data System (ADS)
Jayanthi, Aditya; Coker, Christopher
2016-11-01
In the last decade, CFD simulations have transitioned from the stage where they are used to validate the final designs to the main stream development of products driven by the simulation. However, there are still niche areas of applications liking oiling simulations, where the traditional CFD simulation times are probative to use them in product development and have to rely on experimental methods, which are expensive. In this paper a unique example of Sprocket-Chain simulation will be presented using nanoFluidx a commercial SPH code developed by FluiDyna GmbH and Altair Engineering. The grid less nature of the of SPH method has inherent advantages in the areas of application with complex geometry which pose severe challenge to classical finite volume CFD methods due to complex moving geometries, moving meshes and high resolution requirements leading to long simulation times. The simulations times using nanoFluidx can be reduced from weeks to days allowing the flexibility to run more simulation and can be in used in main stream product development. The example problem under consideration is a classical Multiphysics problem and a sequentially coupled solution of Motion Solve and nanoFluidX will be presented. This abstract is replacing DFD16-2016-000045.
(U) Ristra Next Generation Code Report
DOE Office of Scientific and Technical Information (OSTI.GOV)
Hungerford, Aimee L.; Daniel, David John
LANL’s Weapons Physics management (ADX) and ASC program office have defined a strategy for exascale-class application codes that follows two supportive, and mutually risk-mitigating paths: evolution for established codes (with a strong pedigree within the user community) based upon existing programming paradigms (MPI+X); and Ristra (formerly known as NGC), a high-risk/high-reward push for a next-generation multi-physics, multi-scale simulation toolkit based on emerging advanced programming systems (with an initial focus on data-flow task-based models exemplified by Legion [5]). Development along these paths is supported by the ATDM, IC, and CSSE elements of the ASC program, with the resulting codes forming amore » common ecosystem, and with algorithm and code exchange between them anticipated. Furthermore, solution of some of the more challenging problems of the future will require a federation of codes working together, using established-pedigree codes in partnership with new capabilities as they come on line. The role of Ristra as the high-risk/high-reward path for LANL’s codes is fully consistent with its role in the Advanced Technology Development and Mitigation (ATDM) sub-program of ASC (see Appendix C), in particular its emphasis on evolving ASC capabilities through novel programming models and data management technologies.« less
Progress Towards a Rad-Hydro Code for Modern Computing Architectures LA-UR-10-02825
NASA Astrophysics Data System (ADS)
Wohlbier, J. G.; Lowrie, R. B.; Bergen, B.; Calef, M.
2010-11-01
We are entering an era of high performance computing where data movement is the overwhelming bottleneck to scalable performance, as opposed to the speed of floating-point operations per processor. All multi-core hardware paradigms, whether heterogeneous or homogeneous, be it the Cell processor, GPGPU, or multi-core x86, share this common trait. In multi-physics applications such as inertial confinement fusion or astrophysics, one may be solving multi-material hydrodynamics with tabular equation of state data lookups, radiation transport, nuclear reactions, and charged particle transport in a single time cycle. The algorithms are intensely data dependent, e.g., EOS, opacity, nuclear data, and multi-core hardware memory restrictions are forcing code developers to rethink code and algorithm design. For the past two years LANL has been funding a small effort referred to as Multi-Physics on Multi-Core to explore ideas for code design as pertaining to inertial confinement fusion and astrophysics applications. The near term goals of this project are to have a multi-material radiation hydrodynamics capability, with tabular equation of state lookups, on cartesian and curvilinear block structured meshes. In the longer term we plan to add fully implicit multi-group radiation diffusion and material heat conduction, and block structured AMR. We will report on our progress to date.
OECD-NEA Expert Group on Multi-Physics Experimental Data, Benchmarks and Validation
DOE Office of Scientific and Technical Information (OSTI.GOV)
Valentine, Timothy; Rohatgi, Upendra S.
High-fidelity, multi-physics modeling and simulation (M&S) tools are being developed and utilized for a variety of applications in nuclear science and technology and show great promise in their abilities to reproduce observed phenomena for many applications. Even with the increasing fidelity and sophistication of coupled multi-physics M&S tools, the underpinning models and data still need to be validated against experiments that may require a more complex array of validation data because of the great breadth of the time, energy and spatial domains of the physical phenomena that are being simulated. The Expert Group on Multi-Physics Experimental Data, Benchmarks and Validationmore » (MPEBV) of the Nuclear Energy Agency (NEA) of the Organization for Economic Cooperation and Development (OECD) was formed to address the challenges with the validation of such tools. The work of the MPEBV expert group is shared among three task forces to fulfill its mandate and specific exercises are being developed to demonstrate validation principles for common industrial challenges. This paper describes the overall mission of the group, the specific objectives of the task forces, the linkages among the task forces, and the development of a validation exercise that focuses on a specific reactor challenge problem.« less
Multiphysics Nuclear Thermal Rocket Thrust Chamber Analysis
NASA Technical Reports Server (NTRS)
Wang, Ten-See
2005-01-01
The objective of this effort is t o develop an efficient and accurate thermo-fluid computational methodology to predict environments for hypothetical thrust chamber design and analysis. The current task scope is to perform multidimensional, multiphysics analysis of thrust performance and heat transfer analysis for a hypothetical solid-core, nuclear thermal engine including thrust chamber and nozzle. The multiphysics aspects of the model include: real fluid dynamics, chemical reactivity, turbulent flow, and conjugate heat transfer. The model will be designed to identify thermal, fluid, and hydrogen environments in all flow paths and materials. This model would then be used to perform non- nuclear reproduction of the flow element failures demonstrated in the Rover/NERVA testing, investigate performance of specific configurations and assess potential issues and enhancements. A two-pronged approach will be employed in this effort: a detailed analysis of a multi-channel, flow-element, and global modeling of the entire thrust chamber assembly with a porosity modeling technique. It is expected that the detailed analysis of a single flow element would provide detailed fluid, thermal, and hydrogen environments for stress analysis, while the global thrust chamber assembly analysis would promote understanding of the effects of hydrogen dissociation and heat transfer on thrust performance. These modeling activities will be validated as much as possible by testing performed by other related efforts.
Au99(SPh)42 nanomolecules: aromatic thiolate ligand induced conversion of Au144(SCH2CH2Ph)60.
Nimmala, Praneeth Reddy; Dass, Amala
2014-12-10
A new aromatic thiolate protected gold nanomolecule Au99(SPh)42 has been synthesized by reacting the highly stable Au144(SCH2CH2Ph)60 with thiophenol, HSPh. The ubiquitous Au144(SR)60 is known for its high stability even at elevated temperature and in the presence of excess thiol. This report demonstrates for the first time the reactivity of the Au144(SCH2CH2Ph)60 with thiophenol to form a different 99-Au atom species. The resulting Au99(SPh)42 compound, however, is unreactive and highly stable in the presence of excess aromatic thiol. The molecular formula of the title compound is determined by high resolution electrospray mass spectrometry (ESI-MS) and confirmed by the preparation of the 99-atom nanomolecule using two ligands, namely, Au99(SPh)42 and Au99(SPh-OMe)42. This mass spectrometry study is an unprecedented advance in nanoparticle reaction monitoring, in studying the 144-atom to 99-atom size evolution at such high m/z (∼12k) and resolution. The optical and electrochemical properties of Au99(SPh)42 are reported. Other substituents on the phenyl group, HS-Ph-X, where X = -F, -CH3, -OCH3, also show the Au144 to Au99 core size conversion, suggesting minimal electronic effects for these substituents. Control experiments were conducted by reacting Au144(SCH2CH2Ph)60 with HS-(CH2)n-Ph (where n = 1 and 2), bulky ligands like adamantanethiol and cyclohexanethiol. It was observed that conversion of Au144 to Au99 occurs only when the phenyl group is directly attached to the thiol, suggesting that the formation of a 99-atom species is largely influenced by aromaticity of the ligand and less so on the bulkiness of the ligand.
Liu, Hai-peng; Chen, Rong-yuan; Zhang, Min; Wang, Ke-jian
2010-07-01
To identify the frontline defense molecules against microbial infection in the crab Scylla paramamosain, a live crab pathogenic microbe, Vibrio parahaemolyticus, was recruited as an affinity matrix to isolate innate immune factors from crab hemocytes lysate. Interestingly, a serine proteinase homolog (Sp-SPH) was obtained together with an antimicrobial peptide-antilipopolysaccharide factor (Sp-ALF). We then determined the full-length cDNA sequence of Sp-SPH, which contained 1298bp with an open reading frame of 1107bp encoding 369 amino acid residues. Multiple alignment analysis showed that the deduced amino acid sequences of Sp-SPH shared overall identity (83.8%) with those of SPH-containing proteins from other crab species. Tissue distribution analysis indicated that the Sp-SPH transcripts were present in various tissues including eye stalk, subcuticular epidermis, gill, hemocyte, stomach, thorax ganglion, brain and muscle of S. paramamosain. The Sp-SPH was highly expressed in selected different development stages including embryo (I, II, III and V), zoea (I), megalopa, and juvenile. Importantly, the prophenoloxidase was also present in the embryos, zoea, juvenile and adult crabs, but relatively lower in megalopa compared to those of other stages. Furthermore, the Sp-SPH mRNA expression showed a statistically significant increase (P<0.05) in both hemocyte and subcuticular epidermis at 24h, and in gill at 96h after challenge of V. parahaemolyticus determined by quantitative real-time PCR. Taken together, the live-bacterial-binding activity and the acute-phase response against bacterial infection of Sp-SPH suggested that it might function as an innate immune recognition molecule and play a key role in host defense against microbe invasion in the crab S. paramamosain. Copyright (c) 2010 Elsevier Ltd. All rights reserved.
Modeling Strain Rate Effect of Heterogeneous Materials Using SPH Method
NASA Astrophysics Data System (ADS)
Ma, G. W.; Wang, X. J.; Li, Q. M.
2010-11-01
The strain rate effect on the dynamic compressive failure of heterogeneous material based on the smoothed particle hydrodynamics (SPH) method is studied. The SPH method employs a rate-insensitive elasto-plastic damage model incorporated with a Weibull distribution law to reflect the mechanical behavior of heterogeneous rock-like materials. A series of simulations are performed for heterogeneous specimens by applying axial velocity conditions, which induce different strain-rate loadings to the specimen. A detailed failure process of the specimens in terms of microscopic crack-activities and the macro-mechanical response are discussed. Failure mechanisms between the low and high strain rate cases are compared. The result shows that the strain-rate effects on the rock strength are mainly caused by the changing internal pressure due to the inertial effects as well as the material heterogeneity. It also demonstrates that the inertial effect becomes significant only when the induced strain rate exceeds a threshold, below which, the dynamic strength enhancement can be explained due to the heterogeneities in the material. It also shows that the dynamic strength is affected more significantly for a relatively more heterogeneous specimen, which coincides with the experimental results showing that the poor quality specimen had a relatively larger increase in the dynamic strength.
Evolution of Occupant Survivability Simulation Framework Using FEM-SPH Coupling
2011-08-01
SPH Coupling, Dooge and Thyagarajan. UNCLASSIFIED: Dist A. Approved for public release Page 2 of 14 works outward in the chain: soldier  seats ...reduced degree of freedom (DOF) system, evaluation of occupant seating independent of the vehicle environment, or using a substructure approach to...the ejected material covering the charge imposes most of the loading onto the structure above. The properties of the material in the "soil cap" are
SANTA BARBARA CLUSTER COMPARISON TEST WITH DISPH
DOE Office of Scientific and Technical Information (OSTI.GOV)
Saitoh, Takayuki R.; Makino, Junichiro, E-mail: saitoh@elsi.jp
2016-06-01
The Santa Barbara cluster comparison project revealed that there is a systematic difference between entropy profiles of clusters of galaxies obtained by Eulerian mesh and Lagrangian smoothed particle hydrodynamics (SPH) codes: mesh codes gave a core with a constant entropy, whereas SPH codes did not. One possible reason for this difference is that mesh codes are not Galilean invariant. Another possible reason is the problem of the SPH method, which might give too much “protection” to cold clumps because of the unphysical surface tension induced at contact discontinuities. In this paper, we apply the density-independent formulation of SPH (DISPH), whichmore » can handle contact discontinuities accurately, to simulations of a cluster of galaxies and compare the results with those with the standard SPH. We obtained the entropy core when we adopt DISPH. The size of the core is, however, significantly smaller than those obtained with mesh simulations and is comparable to those obtained with quasi-Lagrangian schemes such as “moving mesh” and “mesh free” schemes. We conclude that both the standard SPH without artificial conductivity and Eulerian mesh codes have serious problems even with such an idealized simulation, while DISPH, SPH with artificial conductivity, and quasi-Lagrangian schemes have sufficient capability to deal with it.« less
SPH-based numerical simulations of flow slides in municipal solid waste landfills.
Huang, Yu; Dai, Zili; Zhang, Weijie; Huang, Maosong
2013-03-01
Most municipal solid waste (MSW) is disposed of in landfills. Over the past few decades, catastrophic flow slides have occurred in MSW landfills around the world, causing substantial economic damage and occasionally resulting in human victims. It is therefore important to predict the run-out, velocity and depth of such slides in order to provide adequate mitigation and protection measures. To overcome the limitations of traditional numerical methods for modelling flow slides, a mesh-free particle method entitled smoothed particle hydrodynamics (SPH) is introduced in this paper. The Navier-Stokes equations were adopted as the governing equations and a Bingham model was adopted to analyse the relationship between material stress rates and particle motion velocity. The accuracy of the model is assessed using a series of verifications, and then flow slides that occurred in landfills located in Sarajevo and Bandung were simulated to extend its applications. The simulated results match the field data well and highlight the capability of the proposed SPH modelling method to simulate such complex phenomena as flow slides in MSW landfills.
A SPH elastic-viscoplastic model for granular flows and bed-load transport
NASA Astrophysics Data System (ADS)
Ghaïtanellis, Alex; Violeau, Damien; Ferrand, Martin; Abderrezzak, Kamal El Kadi; Leroy, Agnès; Joly, Antoine
2018-01-01
An elastic-viscoplastic model (Ulrich, 2013) is combined to a multi-phase SPH formulation (Hu and Adams, 2006; Ghaitanellis et al., 2015) to model granular flows and non-cohesive sediment transport. The soil is treated as a continuum exhibiting a viscoplastic behaviour. Thus, below a critical shear stress (i.e. the yield stress), the soil is assumed to behave as an isotropic linear-elastic solid. When the yield stress is exceeded, the soil flows and behaves as a shear-thinning fluid. A liquid-solid transition threshold based on the granular material properties is proposed, so as to make the model free of numerical parameter. The yield stress is obtained from Drucker-Prager criterion that requires an accurate computation of the effective stress in the soil. A novel method is proposed to compute the effective stress in SPH, solving a Laplace equation. The model is applied to a two-dimensional soil collapse (Bui et al., 2008) and a dam break over mobile beds (Spinewine and Zech, 2007). Results are compared with experimental data and a good agreement is obtained.
Benchmarking the SPHINX and CTH shock physics codes for three problems in ballistics
DOE Office of Scientific and Technical Information (OSTI.GOV)
Wilson, L.T.; Hertel, E.; Schwalbe, L.
1998-02-01
The CTH Eulerian hydrocode, and the SPHINX smooth particle hydrodynamics (SPH) code were used to model a shock tube, two long rod penetrations into semi-infinite steel targets, and a long rod penetration into a spaced plate array. The results were then compared to experimental data. Both SPHINX and CTH modeled the one-dimensional shock tube problem well. Both codes did a reasonable job in modeling the outcome of the axisymmetric rod impact problem. Neither code correctly reproduced the depth of penetration in both experiments. In the 3-D problem, both codes reasonably replicated the penetration of the rod through the first plate.more » After this, however, the predictions of both codes began to diverge from the results seen in the experiment. In terms of computer resources, the run times are problem dependent, and are discussed in the text.« less
NASA Astrophysics Data System (ADS)
Reyes López, Yaidel; Roose, Dirk; Recarey Morfa, Carlos
2013-05-01
In this paper, we present a dynamic refinement algorithm for the smoothed particle Hydrodynamics (SPH) method. An SPH particle is refined by replacing it with smaller daughter particles, which positions are calculated by using a square pattern centered at the position of the refined particle. We determine both the optimal separation and the smoothing distance of the new particles such that the error produced by the refinement in the gradient of the kernel is small and possible numerical instabilities are reduced. We implemented the dynamic refinement procedure into two different models: one for free surface flows, and one for post-failure flow of non-cohesive soil. The results obtained for the test problems indicate that using the dynamic refinement procedure provides a good trade-off between the accuracy and the cost of the simulations.
Identifying personal microbiomes using metagenomic codes
Franzosa, Eric A.; Huang, Katherine; Meadow, James F.; Gevers, Dirk; Lemon, Katherine P.; Bohannan, Brendan J. M.; Huttenhower, Curtis
2015-01-01
Community composition within the human microbiome varies across individuals, but it remains unknown if this variation is sufficient to uniquely identify individuals within large populations or stable enough to identify them over time. We investigated this by developing a hitting set-based coding algorithm and applying it to the Human Microbiome Project population. Our approach defined body site-specific metagenomic codes: sets of microbial taxa or genes prioritized to uniquely and stably identify individuals. Codes capturing strain variation in clade-specific marker genes were able to distinguish among 100s of individuals at an initial sampling time point. In comparisons with follow-up samples collected 30–300 d later, ∼30% of individuals could still be uniquely pinpointed using metagenomic codes from a typical body site; coincidental (false positive) matches were rare. Codes based on the gut microbiome were exceptionally stable and pinpointed >80% of individuals. The failure of a code to match its owner at a later time point was largely explained by the loss of specific microbial strains (at current limits of detection) and was only weakly associated with the length of the sampling interval. In addition to highlighting patterns of temporal variation in the ecology of the human microbiome, this work demonstrates the feasibility of microbiome-based identifiability—a result with important ethical implications for microbiome study design. The datasets and code used in this work are available for download from huttenhower.sph.harvard.edu/idability. PMID:25964341
Kühn, Michael; Lebedkin, Sergei; Weigend, Florian; Eichhöfer, Andreas
2017-01-31
The optical properties of four isostructural trinuclear chalcogenolato bridged metal complexes [Cu 2 Sn(SPh) 6 (PPh 3 ) 2 ], [Cu 2 Sn(SePh) 6 (PPh 3 ) 2 ], [Ag 2 Sn(SPh) 6 (PPh 3 ) 2 ] and [Cu 2 Ti(SPh) 6 (PPh 3 ) 2 ] have been investigated by absorption and photoluminescence spectroscopy and time-dependent density functional theory (TDDFT) calculations. All copper-tin compounds demonstrate near-infrared (NIR) phosphorescence at ∼900-1100 nm in the solid state at low temperature, which is nearly absent at ambient temperature. Stokes shifts of these emissions are found to be unusually large with values of about 1.5 eV. The copper-titanium complex [Cu 2 Ti(SPh) 6 (PPh 3 ) 2 ] also shows luminescence in the NIR at 1090 nm but with a much faster decay (τ ∼ 10 ns at 150 K) and a much smaller Stokes shift (ca. 0.3 eV). Even at 295 K this fluorescence is found to comprise a quantum yield as high as 9.5%. The experimental electronic absorption spectra well correspond to the spectra simulated from the calculated singlet transitions. In line with the large Stokes shifts of the emission spectra the calculations reveal for the copper-tin complexes strong structural relaxation of the excited triplet states whereas those effects are found to be much smaller in the case of the copper-titanium complex.
NASA Technical Reports Server (NTRS)
Jackson, Karen E.; Fuchs, Yvonne T.
2008-01-01
Simulation of multi-terrain impact has been identified as an important research area for improved prediction of rotorcraft crashworthiness within the NASA Subsonic Rotary Wing Aeronautics Program on Rotorcraft Crashworthiness. As part of this effort, two vertical drop tests were conducted of a 5-ft-diameter composite fuselage section into water. For the first test, the fuselage section was impacted in a baseline configuration without energy absorbers. For the second test, the fuselage section was retrofitted with a composite honeycomb energy absorber. Both tests were conducted at a nominal velocity of 25-ft/s. A detailed finite element model was developed to represent each test article and water impact was simulated using both Arbitrary Lagrangian Eulerian (ALE) and Smooth Particle Hydrodynamics (SPH) approaches in LS-DYNA, a nonlinear, explicit transient dynamic finite element code. Analytical predictions were correlated with experimental data for both test configurations. In addition, studies were performed to evaluate the influence of mesh density on test-analysis correlation.
Advanced laser modeling with BLAZE multiphysics
NASA Astrophysics Data System (ADS)
Palla, Andrew D.; Carroll, David L.; Gray, Michael I.; Suzuki, Lui
2017-01-01
The BLAZE Multiphysics™ software simulation suite was specifically developed to model highly complex multiphysical systems in a computationally efficient and highly scalable manner. These capabilities are of particular use when applied to the complexities associated with high energy laser systems that combine subsonic/transonic/supersonic fluid dynamics, chemically reacting flows, laser electronics, heat transfer, optical physics, and in some cases plasma discharges. In this paper we present detailed cw and pulsed gas laser calculations using the BLAZE model with comparisons to data. Simulations of DPAL, XPAL, ElectricOIL (EOIL), and the optically pumped rare gas laser were found to be in good agreement with experimental data.
NASA Astrophysics Data System (ADS)
Shamsoddini, Rahim
2018-04-01
An incompressible smoothed particle hydrodynamics algorithm is proposed to model and investigate the thermal effect on the mixing rate of an active micromixer in which the rotating stirrers enhance the mixing rate. In liquids, mass diffusion increases with increasing temperature, while viscosity decreases; so, the local Schmidt number decreases considerably with increasing temperature. The present study investigates the effect of wall temperature on mixing rate with an improved SPH method. The robust SPH method used in the present work is equipped with a shifting algorithm and renormalization tensors. By introducing this new algorithm, the several mass, momentum, energy, and concentration equations are solved. The results, discussed for different temperature ratios, show that mixing rate increases significantly with increased temperature ratio.
Suturina, Elizaveta A; Nehrkorn, Joscha; Zadrozny, Joseph M; Liu, Junjie; Atanasov, Mihail; Weyhermüller, Thomas; Maganas, Dimitrios; Hill, Stephen; Schnegg, Alexander; Bill, Eckhard; Long, Jeffrey R; Neese, Frank
2017-03-06
The magnetic properties of pseudotetrahedral Co(II) complexes spawned intense interest after (PPh 4 ) 2 [Co(SPh) 4 ] was shown to be the first mononuclear transition-metal complex displaying slow relaxation of the magnetization in the absence of a direct current magnetic field. However, there are differing reports on its fundamental magnetic spin Hamiltonian (SH) parameters, which arise from inherent experimental challenges in detecting large zero-field splittings. There are also remarkable changes in the SH parameters of [Co(SPh) 4 ] 2- upon structural variations, depending on the counterion and crystallization conditions. In this work, four complementary experimental techniques are utilized to unambiguously determine the SH parameters for two different salts of [Co(SPh) 4 ] 2- : (PPh 4 ) 2 [Co(SPh) 4 ] (1) and (NEt 4 ) 2 [Co(SPh) 4 ] (2). The characterization methods employed include multifield SQUID magnetometry, high-field/high-frequency electron paramagnetic resonance (HF-EPR), variable-field variable-temperature magnetic circular dichroism (VTVH-MCD), and frequency domain Fourier transform THz-EPR (FD-FT THz-EPR). Notably, the paramagnetic Co(II) complex [Co(SPh) 4 ] 2- shows strong axial magnetic anisotropy in 1, with D = -55(1) cm -1 and E/D = 0.00(3), but rhombic anisotropy is seen for 2, with D = +11(1) cm -1 and E/D = 0.18(3). Multireference ab initio CASSCF/NEVPT2 calculations enable interpretation of the remarkable variation of D and its dependence on the electronic structure and geometry.
SIERRA Code Coupling Module: Arpeggio User Manual Version 4.44
DOE Office of Scientific and Technical Information (OSTI.GOV)
Subia, Samuel R.; Overfelt, James R.; Baur, David G.
2017-04-01
The SNL Sierra Mechanics code suite is designed to enable simulation of complex multiphysics scenarios. The code suite is composed of several specialized applications which can operate either in standalone mode or coupled with each other. Arpeggio is a supported utility that enables loose coupling of the various Sierra Mechanics applications by providing access to Framework services that facilitate the coupling. More importantly Arpeggio orchestrates the execution of applications that participate in the coupling. This document describes the various components of Arpeggio and their operability. The intent of the document is to provide a fast path for analysts interested inmore » coupled applications via simple examples of its usage.« less
SPH modeling of fluid-solid interaction for dynamic failure analysis of fluid-filled thin shells
NASA Astrophysics Data System (ADS)
Caleyron, F.; Combescure, A.; Faucher, V.; Potapov, S.
2013-05-01
This work concerns the prediction of failure of a fluid-filled tank under impact loading, including the resulting fluid leakage. A water-filled steel cylinder associated with a piston is impacted by a mass falling at a prescribed velocity. The cylinder is closed at its base by an aluminum plate whose characteristics are allowed to vary. The impact on the piston creates a pressure wave in the fluid which is responsible for the deformation of the plate and, possibly, the propagation of cracks. The structural part of the problem is modeled using Mindlin-Reissner finite elements (FE) and Smoothed Particle Hydrodynamics (SPH) shells. The modeling of the fluid is also based on an SPH formulation. The problem involves significant fluid-structure interactions (FSI) which are handled through a master-slave-based method and the pinballs method. Numerical results are compared to experimental data.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Weaver, Robert P.; Miller, Paul; Howley, Kirsten
The NNSA Laboratories have entered into an interagency collaboration with the National Aeronautics and Space Administration (NASA) to explore strategies for prevention of Earth impacts by asteroids. Assessment of such strategies relies upon use of sophisticated multi-physics simulation codes. This document describes the task of verifying and cross-validating, between Lawrence Livermore National Laboratory (LLNL) and Los Alamos National Laboratory (LANL), modeling capabilities and methods to be employed as part of the NNSA-NASA collaboration. The approach has been to develop a set of test problems and then to compare and contrast results obtained by use of a suite of codes, includingmore » MCNP, RAGE, Mercury, Ares, and Spheral. This document provides a short description of the codes, an overview of the idealized test problems, and discussion of the results for deflection by kinetic impactors and stand-off nuclear explosions.« less
A novel phenomenological multi-physics model of Li-ion battery cells
NASA Astrophysics Data System (ADS)
Oh, Ki-Yong; Samad, Nassim A.; Kim, Youngki; Siegel, Jason B.; Stefanopoulou, Anna G.; Epureanu, Bogdan I.
2016-09-01
A novel phenomenological multi-physics model of Lithium-ion battery cells is developed for control and state estimation purposes. The model can capture electrical, thermal, and mechanical behaviors of battery cells under constrained conditions, e.g., battery pack conditions. Specifically, the proposed model predicts the core and surface temperatures and reaction force induced from the volume change of battery cells because of electrochemically- and thermally-induced swelling. Moreover, the model incorporates the influences of changes in preload and ambient temperature on the force considering severe environmental conditions electrified vehicles face. Intensive experimental validation demonstrates that the proposed multi-physics model accurately predicts the surface temperature and reaction force for a wide operational range of preload and ambient temperature. This high fidelity model can be useful for more accurate and robust state of charge estimation considering the complex dynamic behaviors of the battery cell. Furthermore, the inherent simplicity of the mechanical measurements offers distinct advantages to improve the existing power and thermal management strategies for battery management.
Giusto, Kiersten; Ashby, Charles R
2018-01-30
Preterm birth (PTB), defined as birth before 37 completed weeks of gestation, occurs in up to 18 percent of births worldwide and accounts for the majority of perinatal morbidity and mortality. While the single most common cause of PTB has been identified as inflammation, safe and effective pharmacotherapy to prevent PTB has yet to be developed. Our group has used an in vivo model of inflammation driven PTB, biochemical methods, pharmacological approaches, a novel endothelin receptor antagonist that we synthesized and RNA knockdown to help establish the role of endothelin-1 (ET-1) in inflammation-associated PTB. Further, we have used our in vivo model to test whether sphingosine kinase, which acts downstream of ET-1, plays a role in PTB. We have shown that levels of endothelin converting enzyme-1 (ECE-1) and ET-1 are increased when PTB is induced in timed pregnant mice with lipopolysaccharide (LPS) and that blocking ET-1 action, pharmacologically or using ECE-1 RNA silencing, rescues LPS-induced mice from PTB. ET-1 activates the sphingosine kinase/sphingosine-1-phosphate (SphK/S1P) pathway. S1P, in turn, is an important signaling molecule in the pro-inflammatory response. Interestingly, we have shown that SphK inhibition also prevents LPS-induced PTB in timed pregnant mice. Further, we showed that SphK inhibition suppresses the ECE-1/ET-1 axis, implicating positive feedback regulation of the SphK/S1P/ECE-1/ET-1 axis. The ET-1/SphK/SIP pathway is a potential pharmacotherapeutic target for the prevention of PTB. Copyright© Bentham Science Publishers; For any queries, please email at epub@benthamscience.org.
NASA Astrophysics Data System (ADS)
Guo, L.; Yin, Y.; Deng, M.; Guo, L.; Yan, J.
2017-12-01
At present, most magnetotelluric (MT) forward modelling and inversion codes are based on finite difference method. But its structured mesh gridding cannot be well adapted for the conditions with arbitrary topography or complex tectonic structures. By contrast, the finite element method is more accurate in calculating complex and irregular 3-D region and has lower requirement of function smoothness. However, the complexity of mesh gridding and limitation of computer capacity has been affecting its application. COMSOL Multiphysics is a cross-platform finite element analysis, solver and multiphysics full-coupling simulation software. It achieves highly accurate numerical simulations with high computational performance and outstanding multi-field bi-directional coupling analysis capability. In addition, its AC/DC and RF module can be used to easily calculate the electromagnetic responses of complex geological structures. Using the adaptive unstructured grid, the calculation is much faster. In order to improve the discretization technique of computing area, we use the combination of Matlab and COMSOL Multiphysics to establish a general procedure for calculating the MT responses for arbitrary resistivity models. The calculated responses include the surface electric and magnetic field components, impedance components, magnetic transfer functions and phase tensors. Then, the reliability of this procedure is certificated by 1-D, 2-D and 3-D and anisotropic forward modeling tests. Finally, we establish the 3-D lithospheric resistivity model for the Proterozoic Wutai-Hengshan Mts. within the North China Craton by fitting the real MT data collected there. The reliability of the model is also verified by induced vectors and phase tensors. Our model shows more details and better resolution, compared with the previously published 3-D model based on the finite difference method. In conclusion, COMSOL Multiphysics package is suitable for modeling the 3-D lithospheric resistivity
Slow magnetic relaxation at zero field in the tetrahedral complex [Co(SPh)4]2-.
Zadrozny, Joseph M; Long, Jeffrey R
2011-12-28
The Ph(4)P(+) salt of the tetrahedral complex [Co(SPh)(4)](2-), possessing an S = (3)/(2) ground state with an axial zero-field splitting of D = -70 cm(-1), displays single-molecule magnet behavior in the absence of an applied magnetic field. At very low temperatures, ac magnetic susceptibility data show the magnetic relaxation time, τ, to be temperature-independent, while above 2.5 K thermally activated Arrhenius behavior is apparent with U(eff) = 21(1) cm(-1) and τ(0) = 1.0(3) × 10(-7) s. Under an applied field of 1 kOe, τ more closely approximates Arrhenius behavior over the entire temperature range. Upon dilution of the complex within a matrix of the isomorphous compound (Ph(4)P)(2)[Zn(SPh)(4)], ac susceptibility data reveal the molecular nature of the slow magnetic relaxation and indicate that the quantum tunneling pathway observed at low temperatures is likely mediated by intermolecular dipolar interactions. © 2011 American Chemical Society
IMPETUS: Consistent SPH calculations of 3D spherical Bondi accretion onto a black hole
NASA Astrophysics Data System (ADS)
Ramírez-Velasquez, J. M.; Sigalotti, L. Di G.; Gabbasov, R.; Cruz, F.; Klapp, J.
2018-04-01
We present three-dimensional calculations of spherically symmetric Bondi accretion onto a stationary supermassive black hole (SMBH) of mass 108M⊙ within a radial range of 0.02 - 10 pc, using a modified version of the smoothed particle hydrodynamics (SPH) GADGET-2 code, which ensures approximate first-order consistency (i.e., second-order accuracy) for the particle approximation. First-order consistency is restored by allowing the number of neighbours, nneigh, and the smoothing length, h, to vary with the total number of particles, N, such that the asymptotic limits nneigh → ∞ and h → 0 hold as N → ∞. The ability of the method to reproduce the isothermal (γ = 1) and adiabatic (γ = 5/3) Bondi accretion is investigated with increased spatial resolution. In particular, for the isothermal models the numerical radial profiles closely match the Bondi solution, except near the accretor, where the density and radial velocity are slightly underestimated. However, as nneigh is increased and h is decreased, the calculations approach first-order consistency and the deviations from the Bondi solution decrease. The density and radial velocity profiles for the adiabatic models are qualitatively similar to those for the isothermal Bondi accretion. Steady-state Bondi accretion is reproduced by the highly resolved consistent models with a percent relative error of ≲ 1% for γ = 1 and ˜9% for γ = 5/3, with the adiabatic accretion taking longer than the isothermal case to reach steady flow. The performance of the method is assessed by comparing the results with those obtained using the standard GADGET-2 and the GIZMO codes.
An Anisotropic Multiphysics Model for Intervertebral Disk
Gao, Xin; Zhu, Qiaoqiao; Gu, Weiyong
2016-01-01
Intervertebral disk (IVD) is the largest avascular structure in human body, consisting of three types of charged hydrated soft tissues. Its mechanical behavior is nonlinear and anisotropic, due mainly to nonlinear interactions among different constituents within tissues. In this study, a more realistic anisotropic multiphysics model was developed based on the continuum mixture theory and employed to characterize the couplings of multiple physical fields in the IVD. Numerical simulations demonstrate that this model is capable of systematically predicting the mechanical and electrochemical signals within the disk under various loading conditions, which is essential in understanding the mechanobiology of IVD. PMID:27099402
Multiphysics modeling of the steel continuous casting process
NASA Astrophysics Data System (ADS)
Hibbeler, Lance C.
This work develops a macroscale, multiphysics model of the continuous casting of steel. The complete model accounts for the turbulent flow and nonuniform distribution of superheat in the molten steel, the elastic-viscoplastic thermal shrinkage of the solidifying shell, the heat transfer through the shell-mold interface with variable gap size, and the thermal distortion of the mold. These models are coupled together with carefully constructed boundary conditions with the aid of reduced-order models into a single tool to investigate behavior in the mold region, for practical applications such as predicting ideal tapers for a beam-blank mold. The thermal and mechanical behaviors of the mold are explored as part of the overall modeling effort, for funnel molds and for beam-blank molds. These models include high geometric detail and reveal temperature variations on the mold-shell interface that may be responsible for cracks in the shell. Specifically, the funnel mold has a column of mold bolts in the middle of the inside-curve region of the funnel that disturbs the uniformity of the hot face temperatures, which combined with the bending effect of the mold on the shell, can lead to longitudinal facial cracks. The shoulder region of the beam-blank mold shows a local hot spot that can be reduced with additional cooling in this region. The distorted shape of the funnel mold narrow face is validated with recent inclinometer measurements from an operating caster. The calculated hot face temperatures and distorted shapes of the mold are transferred into the multiphysics model of the solidifying shell. The boundary conditions for the first iteration of the multiphysics model come from reduced-order models of the process; one such model is derived in this work for mold heat transfer. The reduced-order model relies on the physics of the solution to the one-dimensional heat-conduction equation to maintain the relationships between inputs and outputs of the model. The geometric
NASA Astrophysics Data System (ADS)
Rutqvist, Jonny; Tsang, Chin-Fu
2012-09-01
The site investigations at Yucca Mountain, Nevada, have provided us with an outstanding data set, one that has significantly advanced our knowledge of multiphysics processes in partially saturated fractured geological media. Such advancement was made possible, foremost, by substantial investments in multiyear field experiments that enabled the study of thermally driven multiphysics and testing of numerical models at a large spatial scale. The development of coupled-process models within the project have resulted in a number of new, advanced multiphysics numerical models that are today applied over a wide range of geoscientific research and geoengineering applications. Using such models, the potential impact of thermal-hydrological-mechanical (THM) multiphysics processes over the long-term (e.g., 10,000 years) could be predicted and bounded with some degree of confidence. The fact that the rock mass at Yucca Mountain is intensively fractured enabled continuum models to be used, although discontinuum models were also applied and are better suited for analyzing some issues, especially those related to predictions of rockfall within open excavations. The work showed that in situ tests (rather than small-scale laboratory experiments alone) are essential for determining appropriate input parameters for multiphysics models of fractured rocks, especially related to parameters defining how permeability might evolve under changing stress and temperature. A significant laboratory test program at Yucca Mountain also made important contributions to the field of rock mechanics, showing a unique relation between porosity and mechanical properties, a time dependency of strength that is significant for long-term excavation stability, a decreasing rock strength with sample size using very large core experiments, and a strong temperature dependency of the thermal expansion coefficient for temperatures up to 200°C. The analysis of in situ heater experiments showed that fracture
IMPETUS - Interactive MultiPhysics Environment for Unified Simulations.
Ha, Vi Q; Lykotrafitis, George
2016-12-08
We introduce IMPETUS - Interactive MultiPhysics Environment for Unified Simulations, an object oriented, easy-to-use, high performance, C++ program for three-dimensional simulations of complex physical systems that can benefit a large variety of research areas, especially in cell mechanics. The program implements cross-communication between locally interacting particles and continuum models residing in the same physical space while a network facilitates long-range particle interactions. Message Passing Interface is used for inter-processor communication for all simulations. Copyright © 2016 Elsevier Ltd. All rights reserved.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Awida, M. H.; Gonin, I.; Passarelli, D.
2016-01-22
Multiphysics analyses for superconducting cavities are essential in the course of cavity design to meet stringent requirements on cavity frequency detuning. Superconducting RF cavities are the core accelerating elements in modern particle accelerators whether it is proton or electron machine, as they offer extremely high quality factors thus reducing the RF losses per cavity. However, the superior quality factor comes with the challenge of controlling the resonance frequency of the cavity within few tens of hertz bandwidth. In this paper, we investigate how the multiphysics analysis plays a major role in proactively minimizing sources of frequency detuning, specifically; microphonics andmore » Lorentz Force Detuning (LFD) in the stage of RF design of the cavity and mechanical design of the niobium shell and the helium vessel.« less
NASA Astrophysics Data System (ADS)
Abdeljabbar Kharrat, Nourhene; Plateaux, Régis; Miladi Chaabane, Mariem; Choley, Jean-Yves; Karra, Chafik; Haddar, Mohamed
2018-05-01
The present work tackles the modeling of multi-physics systems applying a topological approach while proceeding with a new methodology using a topological modification to the structure of systems. Then the comparison with the Magos' methodology is made. Their common ground is the use of connectivity within systems. The comparison and analysis of the different types of modeling show the importance of the topological methodology through the integration of the topological modification to the topological structure of a multi-physics system. In order to validate this methodology, the case of Pogo-stick is studied. The first step consists in generating a topological graph of the system. Then the connectivity step takes into account the contact with the ground. During the last step of this research; the MGS language (Modeling of General System) is used to model the system through equations. Finally, the results are compared to those obtained by MODELICA. Therefore, this proposed methodology may be generalized to model multi-physics systems that can be considered as a set of local elements.
Fully-Implicit Reconstructed Discontinuous Galerkin Method for Stiff Multiphysics Problems
NASA Astrophysics Data System (ADS)
Nourgaliev, Robert
2015-11-01
A new reconstructed Discontinuous Galerkin (rDG) method, based on orthogonal basis/test functions, is developed for fluid flows on unstructured meshes. Orthogonality of basis functions is essential for enabling robust and efficient fully-implicit Newton-Krylov based time integration. The method is designed for generic partial differential equations, including transient, hyperbolic, parabolic or elliptic operators, which are attributed to many multiphysics problems. We demonstrate the method's capabilities for solving compressible fluid-solid systems (in the low Mach number limit), with phase change (melting/solidification), as motivated by applications in Additive Manufacturing. We focus on the method's accuracy (in both space and time), as well as robustness and solvability of the system of linear equations involved in the linearization steps of Newton-based methods. The performance of the developed method is investigated for highly-stiff problems with melting/solidification, emphasizing the advantages from tight coupling of mass, momentum and energy conservation equations, as well as orthogonality of basis functions, which leads to better conditioning of the underlying (approximate) Jacobian matrices, and rapid convergence of the Krylov-based linear solver. This work was performed under the auspices of the U.S. Department of Energy by Lawrence Livermore National Laboratory under Contract DE-AC52-07NA27344, and funded by the LDRD at LLNL under project tracking code 13-SI-002.
Richard, Joshua; Galloway, Jack; Fensin, Michael; ...
2015-04-04
A novel object-oriented modular mapping methodology for externally coupled neutronics–thermal hydraulics multiphysics simulations was developed. The Simulator using MCNP with Integrated Thermal-Hydraulics for Exploratory Reactor Studies (SMITHERS) code performs on-the-fly mapping of material-wise power distribution tallies implemented by MCNP-based neutron transport/depletion solvers for use in estimating coolant temperature and density distributions with a separate thermal-hydraulic solver. The key development of SMITHERS is that it reconstructs the hierarchical geometry structure of the material-wise power generation tallies from the depletion solver automatically, with only a modicum of additional information required from the user. In addition, it performs the basis mapping from themore » combinatorial geometry of the depletion solver to the required geometry of the thermal-hydraulic solver in a generalizable manner, such that it can transparently accommodate varying levels of thermal-hydraulic solver geometric fidelity, from the nodal geometry of multi-channel analysis solvers to the pin-cell level of discretization for sub-channel analysis solvers.« less
NASA Astrophysics Data System (ADS)
Malan, Frederick P.; Singleton, Eric; van Rooyen, Petrus H.; Conradie, Jeanet; Landman, Marilé
2017-11-01
The synthesis, density functional theory (DFT) conformational study and structure analysis of novel two-legged piano stool Ni N-heterocyclic carbene (NHC) complexes and square planar Ni bis-N-heterocyclic carbene complexes, all containing either bromido- or thiophenolato ligands, are described. [CpNi(SPh)(NHC)] complexes were obtained from the neutral 18-electron [CpNiBr(NHC)] complexes by substitution of a bromido ligand with SPh, using NEt3 as a base to abstract the proton of HSPh. The 16-electron biscarbene complexes [Ni(SPh)2{NHC}2] were isolated when an excess of HSPh was added to the reaction mixture. Biscarbene complexes of the type [NiBr2(NHC)2] were obtained in the reaction of NiCp2 with a slight excess of the specific imidazolium bromide salt. The molecular and electronic structures of the mono- and bis-N-heterocyclic carbene complexes have been analysed using single crystal diffraction and density functional theory (DFT) calculations, to give insight into their structural properties.
Application of particle splitting method for both hydrostatic and hydrodynamic cases in SPH
NASA Astrophysics Data System (ADS)
Liu, W. T.; Sun, P. N.; Ming, F. R.; Zhang, A. M.
2018-01-01
Smoothed particle hydrodynamics (SPH) method with numerical diffusive terms shows satisfactory stability and accuracy in some violent fluid-solid interaction problems. However, in most simulations, uniform particle distributions are used and the multi-resolution, which can obviously improve the local accuracy and the overall computational efficiency, has seldom been applied. In this paper, a dynamic particle splitting method is applied and it allows for the simulation of both hydrostatic and hydrodynamic problems. The splitting algorithm is that, when a coarse (mother) particle enters the splitting region, it will be split into four daughter particles, which inherit the physical parameters of the mother particle. In the particle splitting process, conservations of mass, momentum and energy are ensured. Based on the error analysis, the splitting technique is designed to allow the optimal accuracy at the interface between the coarse and refined particles and this is particularly important in the simulation of hydrostatic cases. Finally, the scheme is validated by five basic cases, which demonstrate that the present SPH model with a particle splitting technique is of high accuracy and efficiency and is capable for the simulation of a wide range of hydrodynamic problems.
Analysis of image formation in optical coherence elastography using a multiphysics approach
Chin, Lixin; Curatolo, Andrea; Kennedy, Brendan F.; Doyle, Barry J.; Munro, Peter R. T.; McLaughlin, Robert A.; Sampson, David D.
2014-01-01
Image formation in optical coherence elastography (OCE) results from a combination of two processes: the mechanical deformation imparted to the sample and the detection of the resulting displacement using optical coherence tomography (OCT). We present a multiphysics model of these processes, validated by simulating strain elastograms acquired using phase-sensitive compression OCE, and demonstrating close correspondence with experimental results. Using the model, we present evidence that the approximation commonly used to infer sample displacement in phase-sensitive OCE is invalidated for smaller deformations than has been previously considered, significantly affecting the measurement precision, as quantified by the displacement sensitivity and the elastogram signal-to-noise ratio. We show how the precision of OCE is affected not only by OCT shot-noise, as is usually considered, but additionally by phase decorrelation due to the sample deformation. This multiphysics model provides a general framework that could be used to compare and contrast different OCE techniques. PMID:25401007
Autissier, Valerie; Henderson, Richard A
2008-07-21
The kinetics of the reactions between [Zn4(SPh)10](2-) and an excess of MX2 (M = Co, X = NO3 or Cl; M = Fe, X = Cl), in which a Zn(II) is replaced by M(II), have been studied in MeCN at 25.0 degrees C. (1)H NMR spectroscopy shows that the ultimate product of the reactions is an equilibrium mixture of clusters of composition [Zn(n)M(4-n)(SPh)10](2-), and this is reflected in the multiphasic absorbance-time curves observed over protracted times (several minutes) using stopped-flow spectrophotometry to study the reactions. The kinetics of only the first phase have been determined, corresponding to the equilibrium formation of [Zn3M(SPh)10](2-). The effects of varying the concentrations of cluster, MX2, and ZnCl2 on the kinetics have been investigated. The rate law is consistent with the equilibrium nature of the metal exchange process and indicates a mechanism for the formation of [Zn3M(SPh)10](2-) involving two coupled equilibria. In the initial step binding of MX2 to a bridging thiolate in [Zn4(SPh)10](2-) results in breaking of a Zn-bridging thiolate bond. In the second step replacement of the cluster Zn involves transfer of the bridging thiolates from the Zn to M, with breaking of a Zn-bridged thiolate bond being rate-limiting. The kinetics for the reaction of ZnCl2 with [Zn3M(SPh)10](2-) (M = Fe or Co)} depends on the identity of M. This behavior indicates attack of ZnCl2 at a M-mu-SPh-Zn bridged thiolate. Similar studies on the analogous reactions between [Fe4(SPh)10](2-) and an excess of CoX2 (X = NO3 or Cl) in MeCN exhibit simpler kinetics but these are also consistent with the same mechanism.
Jiang, Jian-Bing; Bian, Guo-Qing; Zhang, Ya-Ping; Luo, Wen; Zhu, Qin-Yu; Dai, Jie
2011-10-07
Three anion-cation compounds 1-3 with formula [M(phen)(3)][Cd(4)(SPh)(10)]·Sol (M = Ru(2+), Fe(2+), and Ni(2+), Sol = MeCN and H(2)O) have been synthesized and characterized by single-crystal analysis. Both the cations and anion are well-known ions, but the properties of the co-assembled compounds are interesting. Molecular structures and charge-transfer between the cations and anions in crystal and even in solution are discussed. These compounds are isomorphous and short inter-ion interactions are found in these crystals, such as π···π stacking and C-H···π contacts. Both spectroscopic and theoretical calculated results indicate that there is anion-cation charge-transfer (ACCT) between the Ru-phen complex dye and the Cd-SPh cluster, which plays an important role in their photophysical properties. The intensity of the fluorescent emission of the [Ru(phen)(3)](2+) is enhanced when the cation interacts with the [Cd(4)(SPh)(10)](2-) anion. The mechanism for the enhancement of photoluminescence has been proposed.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Anh Bui; Nam Dinh; Brian Williams
In addition to validation data plan, development of advanced techniques for calibration and validation of complex multiscale, multiphysics nuclear reactor simulation codes are a main objective of the CASL VUQ plan. Advanced modeling of LWR systems normally involves a range of physico-chemical models describing multiple interacting phenomena, such as thermal hydraulics, reactor physics, coolant chemistry, etc., which occur over a wide range of spatial and temporal scales. To a large extent, the accuracy of (and uncertainty in) overall model predictions is determined by the correctness of various sub-models, which are not conservation-laws based, but empirically derived from measurement data. Suchmore » sub-models normally require extensive calibration before the models can be applied to analysis of real reactor problems. This work demonstrates a case study of calibration of a common model of subcooled flow boiling, which is an important multiscale, multiphysics phenomenon in LWR thermal hydraulics. The calibration process is based on a new strategy of model-data integration, in which, all sub-models are simultaneously analyzed and calibrated using multiple sets of data of different types. Specifically, both data on large-scale distributions of void fraction and fluid temperature and data on small-scale physics of wall evaporation were simultaneously used in this work’s calibration. In a departure from traditional (or common-sense) practice of tuning/calibrating complex models, a modern calibration technique based on statistical modeling and Bayesian inference was employed, which allowed simultaneous calibration of multiple sub-models (and related parameters) using different datasets. Quality of data (relevancy, scalability, and uncertainty) could be taken into consideration in the calibration process. This work presents a step forward in the development and realization of the “CIPS Validation Data Plan” at the Consortium for Advanced Simulation of LWRs to
Maestro and Castro: Simulation Codes for Astrophysical Flows
NASA Astrophysics Data System (ADS)
Zingale, Michael; Almgren, Ann; Beckner, Vince; Bell, John; Friesen, Brian; Jacobs, Adam; Katz, Maximilian P.; Malone, Christopher; Nonaka, Andrew; Zhang, Weiqun
2017-01-01
Stellar explosions are multiphysics problems—modeling them requires the coordinated input of gravity solvers, reaction networks, radiation transport, and hydrodynamics together with microphysics recipes to describe the physics of matter under extreme conditions. Furthermore, these models involve following a wide range of spatial and temporal scales, which puts tough demands on simulation codes. We developed the codes Maestro and Castro to meet the computational challenges of these problems. Maestro uses a low Mach number formulation of the hydrodynamics to efficiently model convection. Castro solves the fully compressible radiation hydrodynamics equations to capture the explosive phases of stellar phenomena. Both codes are built upon the BoxLib adaptive mesh refinement library, which prepares them for next-generation exascale computers. Common microphysics shared between the codes allows us to transfer a problem from the low Mach number regime in Maestro to the explosive regime in Castro. Importantly, both codes are freely available (https://github.com/BoxLib-Codes). We will describe the design of the codes and some of their science applications, as well as future development directions.Support for development was provided by NSF award AST-1211563 and DOE/Office of Nuclear Physics grant DE-FG02-87ER40317 to Stony Brook and by the Applied Mathematics Program of the DOE Office of Advance Scientific Computing Research under US DOE contract DE-AC02-05CH11231 to LBNL.
Two-Step Multi-Physics Analysis of an Annular Linear Induction Pump for Fission Power Systems
NASA Technical Reports Server (NTRS)
Geng, Steven M.; Reid, Terry V.
2016-01-01
One of the key technologies associated with fission power systems (FPS) is the annular linear induction pump (ALIP). ALIPs are used to circulate liquid-metal fluid for transporting thermal energy from the nuclear reactor to the power conversion device. ALIPs designed and built to date for FPS project applications have not performed up to expectations. A unique, two-step approach was taken toward the multi-physics examination of an ALIP using ANSYS Maxwell 3D and Fluent. This multi-physics approach was developed so that engineers could investigate design variations that might improve pump performance. Of interest was to determine if simple geometric modifications could be made to the ALIP components with the goal of increasing the Lorentz forces acting on the liquid-metal fluid, which in turn would increase pumping capacity. The multi-physics model first calculates the Lorentz forces acting on the liquid metal fluid in the ALIP annulus. These forces are then used in a computational fluid dynamics simulation as (a) internal boundary conditions and (b) source functions in the momentum equations within the Navier-Stokes equations. The end result of the two-step analysis is a predicted pump pressure rise that can be compared with experimental data.
Verification of low-Mach number combustion codes using the method of manufactured solutions
NASA Astrophysics Data System (ADS)
Shunn, Lee; Ham, Frank; Knupp, Patrick; Moin, Parviz
2007-11-01
Many computational combustion models rely on tabulated constitutive relations to close the system of equations. As these reactive state-equations are typically multi-dimensional and highly non-linear, their implications on the convergence and accuracy of simulation codes are not well understood. In this presentation, the effects of tabulated state-relationships on the computational performance of low-Mach number combustion codes are explored using the method of manufactured solutions (MMS). Several MMS examples are developed and applied, progressing from simple one-dimensional configurations to problems involving higher dimensionality and solution-complexity. The manufactured solutions are implemented in two multi-physics hydrodynamics codes: CDP developed at Stanford University and FUEGO developed at Sandia National Laboratories. In addition to verifying the order-of-accuracy of the codes, the MMS problems help highlight certain robustness issues in existing variable-density flow-solvers. Strategies to overcome these issues are briefly discussed.
A splitting integration scheme for the SPH simulation of concentrated particle suspensions
NASA Astrophysics Data System (ADS)
Bian, Xin; Ellero, Marco
2014-01-01
Simulating nearly contacting solid particles in suspension is a challenging task due to the diverging behavior of short-range lubrication forces, which pose a serious time-step limitation for explicit integration schemes. This general difficulty limits severely the total duration of simulations of concentrated suspensions. Inspired by the ideas developed in [S. Litvinov, M. Ellero, X.Y. Hu, N.A. Adams, J. Comput. Phys. 229 (2010) 5457-5464] for the simulation of highly dissipative fluids, we propose in this work a splitting integration scheme for the direct simulation of solid particles suspended in a Newtonian liquid. The scheme separates the contributions of different forces acting on the solid particles. In particular, intermediate- and long-range multi-body hydrodynamic forces, which are computed from the discretization of the Navier-Stokes equations using the smoothed particle hydrodynamics (SPH) method, are taken into account using an explicit integration; for short-range lubrication forces, velocities of pairwise interacting solid particles are updated implicitly by sweeping over all the neighboring pairs iteratively, until convergence in the solution is obtained. By using the splitting integration, simulations can be run stably and efficiently up to very large solid particle concentrations. Moreover, the proposed scheme is not limited to the SPH method presented here, but can be easily applied to other simulation techniques employed for particulate suspensions.
Applications of ANSYS/Multiphysics at NASA/Goddard Space Flight Center
NASA Technical Reports Server (NTRS)
Loughlin, Jim
2007-01-01
This viewgraph presentation reviews some of the uses that the ANSYS/Multiphysics system is used for at the NASA Goddard Space Flight Center. Some of the uses of the ANSYS system is used for is MEMS Structural Analysis of Micro-mirror Array for the James Web Space Telescope (JWST), Micro-shutter Array for JWST, MEMS FP Tunable Filter, AstroE2 Micro-calorimeter. Various views of these projects are shown in this presentation.
Smoothed Particle Hydrodynamic Simulator
DOE Office of Scientific and Technical Information (OSTI.GOV)
2016-10-05
This code is a highly modular framework for developing smoothed particle hydrodynamic (SPH) simulations running on parallel platforms. The compartmentalization of the code allows for rapid development of new SPH applications and modifications of existing algorithms. The compartmentalization also allows changes in one part of the code used by many applications to instantly be made available to all applications.
Nimmala, Praneeth Reddy; Theivendran, Shevanuja; Barcaro, Giovanni; Sementa, Luca; Kumara, Chanaka; Jupally, Vijay Reddy; Apra, Edoardo; Stener, Mauro; Fortunelli, Alessandro; Dass, Amala
2015-06-04
Ultrastable gold nanomolecule Au144(SCH2CH2Ph)60 upon etching with excess tert-butylbenzenethiol undergoes a core-size conversion and compositional change to form an entirely new core of Au133(SPh-tBu)52. This conversion was studied using high-resolution electrospray mass spectrometry which shows that the core size conversion is initiated after 22 ligand exchanges, suggesting a relatively high stability of the Au144(SCH2CH2Ph)38(SPh-tBu)22 intermediate. The Au144 → Au133 core size conversion is surprisingly different from the Au144 → Au99 core conversion reported in the case of thiophenol, -SPh. Theoretical analysis and ab initio molecular dynamics simulations show that rigid p-tBu groups play a crucial role by reducing the cluster structural freedom, and protecting the cluster from adsorption of exogenous and reactive species, thus rationalizing the kinetic factors that stabilize the Au133 core size. This 144-atom to 133-atom nanomolecule's compositional change is reflected in optical spectroscopy and electrochemistry.
NASA Astrophysics Data System (ADS)
Huang, J. H.; Wang, X. J.; Wang, J.
2016-02-01
The primary purpose of this paper is to propose a mathematical model of PLZT ceramic with coupled multi-physics fields, e.g. thermal, electric, mechanical and light field. To this end, the coupling relationships of multi-physics fields and the mechanism of some effects resulting in the photostrictive effect are analyzed theoretically, based on which a mathematical model considering coupled multi-physics fields is established. According to the analysis and experimental results, the mathematical model can explain the hysteresis phenomenon and the variation trend of the photo-induced voltage very well and is in agreement with the experimental curves. In addition, the PLZT bimorph is applied as an energy transducer for a photovoltaic-electrostatic hybrid actuated micromirror, and the relation of the rotation angle and the photo-induced voltage is discussed based on the novel photostrictive mathematical model.
NASA Astrophysics Data System (ADS)
De Padova, Diana; Mossa, Michele; Sibilla, Stefano
2018-02-01
This paper shows the results of the smooth particle hydrodynamics (SPH) modelling of the hydraulic jump at an abrupt drop, where the transition from supercritical to subcritical flow is characterised by several flow patterns depending upon the inflow and tailwater conditions. SPH simulations are obtained by a pseudo-compressible XSPH scheme with pressure smoothing; turbulent stresses are represented either by an algebraic mixing-length model, or by a two-equation k- ɛ model. The numerical model is applied to analyse the occurrence of oscillatory flow conditions between two different jump types characterised by quasi-periodic oscillation, and the results are compared with experiments performed at the hydraulics laboratory of Bari Technical University. The purpose of this paper is to obtain a deeper understanding of the physical features of a flow which is in general difficult to be reproduced numerically, owing to its unstable character: in particular, vorticity and turbulent kinetic energy fields, velocity, water depth and pressure spectra downstream of the jump, and velocity and pressure cross-correlations can be computed and analysed.
Plank, G; Prassl, AJ; Augustin, C
2014-01-01
Despite the evident multiphysics nature of the heart – it is an electrically controlled mechanical pump – most modeling studies considered electrophysiology and mechanics in isolation. In no small part, this is due to the formidable modeling challenges involved in building strongly coupled anatomically accurate and biophyically detailed multi-scale multi-physics models of cardiac electro-mechanics. Among the main challenges are the selection of model components and their adjustments to achieve integration into a consistent organ-scale model, dealing with technical difficulties such as the exchange of data between electro-physiological and mechanical model, particularly when using different spatio-temporal grids for discretization, and, finally, the implementation of advanced numerical techniques to deal with the substantial computational. In this study we report on progress made in developing a novel modeling framework suited to tackle these challenges. PMID:24043050
Zhang, Guangmei; Lu, Zhi-Qiang; Jiang, Haobo; Asgari, Sassan
2004-05-01
Most parasitic wasps inject maternal factors into the host hemocoel to suppress the host immune system and ensure successful development of their progeny. Melanization is one of the insect defence mechanisms against intruding pathogens or parasites. We previously isolated from the venom of Cotesia rubecula a 50 kDa protein that blocked melanization in the hemolymph of its host, Pieris rapae [Insect Biochem. Mol. Biol. 33 (2003) 1017]. This protein, designated Vn50, is a serine proteinase homolog (SPH) containing an amino-terminal clip domain. In this work, we demonstrated that recombinant Vn50 bound P. rapae hemolymph components that were recognized by antisera to Tenebrio molitor prophenoloxidase (proPO) and Manduca sexta proPO-activating proteinase (PAP). Vn50 is stable in the host hemolymph-it remained intact for at least 72 h after parasitization. Using M. sexta as a model system, we found that Vn50 efficiently down-regulated proPO activation mediated by M. sexta PAP-1, SPH-1, and SPH-2. Vn50 did not inhibit active phenoloxidase (PO) or PAP-1, but it significantly reduced the proteolysis of proPO. If recombinant Vn50 binds P. rapae proPO and PAP (as suggested by the antibody reactions), it is likely that the molecular interactions among M. sexta proPO, PAP-1, and SPHs were impaired by this venom protein. A similar strategy might be employed by C. rubecula to negatively impact the proPO activation reaction in its natural host.
Design and multiphysics analysis of a 176Â MHz continuous-wave radio-frequency quadrupole
NASA Astrophysics Data System (ADS)
Kutsaev, S. V.; Mustapha, B.; Ostroumov, P. N.; Barcikowski, A.; Schrage, D.; Rodnizki, J.; Berkovits, D.
2014-07-01
We have developed a new design for a 176 MHz cw radio-frequency quadrupole (RFQ) for the SARAF upgrade project. At this frequency, the proposed design is a conventional four-vane structure. The main design goals are to provide the highest possible shunt impedance while limiting the required rf power to about 120 kW for reliable cw operation, and the length to about 4 meters. If built as designed, the proposed RFQ will be the first four-vane cw RFQ built as a single cavity (no resonant coupling required) that does not require π-mode stabilizing loops or dipole rods. For this, we rely on very detailed 3D simulations of all aspects of the structure and the level of machining precision achieved on the recently developed ATLAS upgrade RFQ. A full 3D model of the structure including vane modulation was developed. The design was optimized using electromagnetic and multiphysics simulations. Following the choice of the vane type and geometry, the vane undercuts were optimized to produce a flat field along the structure. The final design has good mode separation and should not need dipole rods if built as designed, but their effect was studied in the case of manufacturing errors. The tuners were also designed and optimized to tune the main mode without affecting the field flatness. Following the electromagnetic (EM) design optimization, a multiphysics engineering analysis of the structure was performed. The multiphysics analysis is a coupled electromagnetic, thermal and mechanical analysis. The cooling channels, including their paths and sizes, were optimized based on the limiting temperature and deformation requirements. The frequency sensitivity to the RFQ body and vane cooling water temperatures was carefully studied in order to use it for frequency fine-tuning. Finally, an inductive rf power coupler design based on the ATLAS RFQ coupler was developed and simulated. The EM design optimization was performed using cst Microwave Studio and the results were verified using
Chen, Chen; Lei, Wenrui; Lu, Min; Zhang, Jianan; Zhang, Zhou; Luo, Chunling; Chen, Yahua; Hong, Qing; Shen, Zhenguo
2016-04-01
Soil that is co-contaminated with heavy metals (HMs) and polycyclic aromatic hydrocarbons (PAHs) is difficult to bioremediate due to the ability of toxic metals to inhibit PAH degradation by bacteria. We demonstrated the resistance mechanisms to Cu(II) and Cd(II) of two newly isolated strains of Sphingobium sp. PHE-SPH and Ochrobactrum sp. PHE-OCH and further tested their potential application in the bioremediation of HM-phenanthrene (PhA) co-contaminated sites. The PHE-SPH and PHE-OCH strains tolerated 4.63 and 4.34 mM Cu(II) and also showed tolerance to 0.48 and 1.52 mM Cd(II), respectively. Diverse resistance patterns were detected between the two strains. In PHE-OCH cells, the maximum accumulation of Cu(II) occurred in the cell wall, while the maximum accumulation was in the cytoplasm of PHE-SPH cells. This resulted in a sudden suppression of growth in PHE-OCH and a gradual inhibition in PHE-SPH as the concentration of Cu(II) increased. Organic acid production was markedly higher in PHE-OCH than in PHE-SPH, which may also have a role in the resistance mechanisms, and contributes to the higher Cd(II) tolerance of PHE-OCH. The factors involved in the absorption of Cu(II) or Cd(II) in PHE-SPH and PHE-OCH were identified as proteins and carbohydrates by Fourier transform infrared (FT-IR) spectroscopy. Furthermore, both strains showed the ability to efficiently degrade PhA and maintained this high degradation efficiency under HM stress. The high tolerance to HMs and the PhA degradation capacity make Sphingobium sp. PHE-SPH and Ochrobactrum sp. PHE-OCH excellent candidate organisms for the bioremediation of HM-PhA co-contaminated sites.
Overview of SPH-ALE applications for hydraulic turbines in ANDRITZ Hydro
NASA Astrophysics Data System (ADS)
Rentschler, M.; Marongiu, J. C.; Neuhauser, M.; Parkinson, E.
2018-02-01
Over the past 13 years, ANDRITZ Hydro has developed an in-house tool based on the SPH-ALE method for applications in flow simulations in hydraulic turbines. The initial motivation is related to the challenging simulation of free surface flows in Pelton turbines, where highly dynamic water jets interact with rotating buckets, creating thin water jets traveling inside the housing and possibly causing disturbances on the runner. The present paper proposes an overview of industrial applications allowed by the developed tool, including design evaluation of Pelton runners and casings, transient operation of Pelton units and free surface flows in hydraulic structures.
Petascale computation of multi-physics seismic simulations
NASA Astrophysics Data System (ADS)
Gabriel, Alice-Agnes; Madden, Elizabeth H.; Ulrich, Thomas; Wollherr, Stephanie; Duru, Kenneth C.
2017-04-01
Capturing the observed complexity of earthquake sources in concurrence with seismic wave propagation simulations is an inherently multi-scale, multi-physics problem. In this presentation, we present simulations of earthquake scenarios resolving high-detail dynamic rupture evolution and high frequency ground motion. The simulations combine a multitude of representations of model complexity; such as non-linear fault friction, thermal and fluid effects, heterogeneous fault stress and fault strength initial conditions, fault curvature and roughness, on- and off-fault non-elastic failure to capture dynamic rupture behavior at the source; and seismic wave attenuation, 3D subsurface structure and bathymetry impacting seismic wave propagation. Performing such scenarios at the necessary spatio-temporal resolution requires highly optimized and massively parallel simulation tools which can efficiently exploit HPC facilities. Our up to multi-PetaFLOP simulations are performed with SeisSol (www.seissol.org), an open-source software package based on an ADER-Discontinuous Galerkin (DG) scheme solving the seismic wave equations in velocity-stress formulation in elastic, viscoelastic, and viscoplastic media with high-order accuracy in time and space. Our flux-based implementation of frictional failure remains free of spurious oscillations. Tetrahedral unstructured meshes allow for complicated model geometry. SeisSol has been optimized on all software levels, including: assembler-level DG kernels which obtain 50% peak performance on some of the largest supercomputers worldwide; an overlapping MPI-OpenMP parallelization shadowing the multiphysics computations; usage of local time stepping; parallel input and output schemes and direct interfaces to community standard data formats. All these factors enable aim to minimise the time-to-solution. The results presented highlight the fact that modern numerical methods and hardware-aware optimization for modern supercomputers are essential
Matsunaga, James; Medeiros, Marco A; Sanchez, Yolanda; Werneid, Kristian F; Ko, Albert I
2007-10-01
The life cycle of the pathogen Leptospira interrogans involves stages outside and inside the host. Entry of L. interrogans from moist environments into the host is likely to be accompanied by the induction of genes encoding virulence determinants and the concomitant repression of genes encoding products required for survival outside of the host. The expression of the adhesin LigA, the haemolysin Sph2 (Lk73.5) and the outer-membrane lipoprotein LipL36 of pathogenic Leptospira species have been reported to be regulated by mammalian host signals. A previous study demonstrated that raising the osmolarity of the leptospiral growth medium to physiological levels encountered in the host by addition of various salts enhanced the levels of cell-associated LigA and LigB and extracellular LigA. In this study, we systematically examined the effects of osmotic upshift with ionic and non-ionic solutes on expression of the known mammalian host-regulated leptospiral genes. The levels of cell-associated LigA, LigB and Sph2 increased at physiological osmolarity, whereas LipL36 levels decreased, corresponding to changes in specific transcript levels. These changes in expression occurred irrespective of whether sodium chloride or sucrose was used as the solute. The increase of cellular LigA, LigB and Sph2 protein levels occurred within hours of adding sodium chloride. Extracellular Sph2 levels increased when either sodium chloride or sucrose was added to achieve physiological osmolarity. In contrast, enhanced levels of extracellular LigA were observed only with an increase in ionic strength. These results indicate that the mechanisms for release of LigA and Sph2 differ during host infection. Thus, osmolarity not only affects leptospiral gene expression by affecting transcript levels of putative virulence determinants but also affects the release of such proteins into the surroundings.
A micro-macro coupling approach of MD-SPH method for reactive energetic materials
NASA Astrophysics Data System (ADS)
Liu, Gui Rong; Wang, Guang Yu; Peng, Qing; De, Suvranu
2017-01-01
The simulation of reactive energetic materials has long been the interest of researchers because of the extensive applications of explosives. Much research has been done on the subject at macro scale in the past and research at micro scale has been initiated recently. Equation of state (EoS) is the relation between physical quantities (pressure, temperature, energy and volume) describing thermodynamic states of materials under a given set of conditions. It plays a significant role in determining the characteristics of energetic materials, including Chapman-Jouguet point and detonation velocity. Furthermore, EoS is the key to connect microscopic and macroscopic phenomenon when simulating the macro effects of an explosion. For instance, an ignition and growth model for high explosives uses two JWL EoSs, one for solid explosive and the other for gaseous products, which are often obtained from experiments that can be quite expensive and hazardous. Therefore, it is ideal to calculate the EoS of energetic materials through computational means. In this paper, the EoSs for both solid and gaseous products of β-HMX are calculated using molecular dynamics simulation with ReaxFF-d3, a reactive force field obtained from quantum mechanics. The microscopic simulation results are then compared with experiments and the continuum ignition and growth model. Good agreement is observed. Then, the EoSs obtained through micro-scale simulation is applied in a smoothed particle hydrodynamics (SPH) code to simulate the macro effects of explosions. Simulation results are compared with experiments.
Multi-Physics Analysis of the Fermilab Booster RF Cavity
DOE Office of Scientific and Technical Information (OSTI.GOV)
Awida, M.; Reid, J.; Yakovlev, V.
After about 40 years of operation the RF accelerating cavities in Fermilab Booster need an upgrade to improve their reliability and to increase the repetition rate in order to support a future experimental program. An increase in the repetitio n rate from 7 to 15 Hz entails increasing the power dissipation in the RF cavities, their ferrite loaded tuners, and HOM dampers. The increased duty factor requires careful modelling for the RF heating effects in the cavity. A multi-physic analysis invest igating both the RF and thermal properties of Booster cavity under various operating conditions is presented in this paper.
Multi-Physics Analysis of the Fermilab Booster RF Cavity
DOE Office of Scientific and Technical Information (OSTI.GOV)
Awida, M.; Reid, J.; Yakovlev, V.
After about 40 years of operation the RF accelerating cavities in Fermilab Booster need an upgrade to improve their reliability and to increase the repetition rate in order to support a future experimental program. An increase in the repetition rate from 7 to 15 Hz entails increasing the power dissipation in the RF cavities, their ferrite loaded tuners, and HOM dampers. The increased duty factor requires careful modelling for the RF heating effects in the cavity. A multi-physic analysis investigating both the RF and thermal properties of Booster cavity under various operating conditions is presented in this paper.
A program code generator for multiphysics biological simulation using markup languages.
Amano, Akira; Kawabata, Masanari; Yamashita, Yoshiharu; Rusty Punzalan, Florencio; Shimayoshi, Takao; Kuwabara, Hiroaki; Kunieda, Yoshitoshi
2012-01-01
To cope with the complexity of the biological function simulation models, model representation with description language is becoming popular. However, simulation software itself becomes complex in these environment, thus, it is difficult to modify the simulation conditions, target computation resources or calculation methods. In the complex biological function simulation software, there are 1) model equations, 2) boundary conditions and 3) calculation schemes. Use of description model file is useful for first point and partly second point, however, third point is difficult to handle for various calculation schemes which is required for simulation models constructed from two or more elementary models. We introduce a simulation software generation system which use description language based description of coupling calculation scheme together with cell model description file. By using this software, we can easily generate biological simulation code with variety of coupling calculation schemes. To show the efficiency of our system, example of coupling calculation scheme with three elementary models are shown.
Tsou, Chih-Chin; Lin, Zong-Sian; Lu, Tsai-Te; Liaw, Wen-Feng
2008-12-17
Transformation of dinitrosyl iron complexes (DNICs) [(NO)(2)Fe(SR)(2)](-) (R = Et, Ph) into [4Fe-4S] clusters [Fe(4)S(4)(SPh)(4)](2-) in the presence of [Fe(SPh)(4)](2-/1-) and S-donor species S(8) via the reassembling process ([(NO)(2)Fe(SR)(2)](-) --> [Fe(4)S(3)(NO)(7)](-) (1)/[Fe(4)S(3)(NO)(7)](2-) (2) --> [Fe(4)S(4)(NO)(4)](2-) (3) --> [Fe(4)S(4)(SPh)(4)](2-) (5)) was demonstrated. Reaction of [(NO)(2)Fe(SR)(2)](-) (R = Et, Ph) with S(8) in THF, followed by the addition of HBF(4) into the mixture solution, yielded complex [Fe(4)S(3)(NO)(7)](-) (1). Complex [Fe(4)S(3)(NO)(7)](2-) (2), obtained from reduction of complex 1 by [Na][biphenyl], was converted into complex [Fe(4)S(4)(NO)(4)](2-) (3) along with byproduct [(NO)(2)Fe(SR)(2)](-) via the proposed [Fe(4)S(3)(SPh)(NO)(4)](2-) intermediate upon treating complex 2 with 1.5 equiv of [Fe(SPh)(4)](2-) and the subsequent addition of 1/8 equiv of S(8) in CH(3)CN at ambient temperature. Complex 3 was characterized by IR, UV-vis, and single-crystal X-ray diffraction. Upon addition of complex 3 to the CH(3)CN solution of [Fe(SPh)(4)](-) in a 1:2 molar ratio at ambient temperature, the rapid NO radical-thiyl radical exchange reaction between complex 3 and the biomimetic oxidized form of rubredoxin [Fe(SPh)(4)](-) occurred, leading to the simultaneous formation of [4Fe-4S] cluster [Fe(4)S(4)(SPh)(4)](2-) (5) and DNIC [(NO)(2)Fe(SPh)(2)](-). This result demonstrates a successful biomimetic reassembly of [4Fe-4S] cluster [Fe(4)S(4)(SPh)(4)](2-) from NO-modified [Fe-S] clusters, relevant to the repair of DNICs derived from nitrosylation of [4Fe-4S] clusters of endonuclease III back to [4Fe-4S] clusters upon addition of ferrous ion, cysteine, and IscS.
Spatio-Temporal Process Simulation of Dam-Break Flood Based on SPH
NASA Astrophysics Data System (ADS)
Wang, H.; Ye, F.; Ouyang, S.; Li, Z.
2018-04-01
On the basis of introducing the SPH (Smooth Particle Hydrodynamics) simulation method, the key research problems were given solutions in this paper, which ere the spatial scale and temporal scale adapting to the GIS(Geographical Information System) application, the boundary condition equations combined with the underlying surface, and the kernel function and parameters applicable to dam-break flood simulation. In this regards, a calculation method of spatio-temporal process emulation with elaborate particles for dam-break flood was proposed. Moreover the spatio-temporal process was dynamic simulated by using GIS modelling and visualization. The results show that the method gets more information, objectiveness and real situations.
A generalized transport-velocity formulation for smoothed particle hydrodynamics
DOE Office of Scientific and Technical Information (OSTI.GOV)
Zhang, Chi; Hu, Xiangyu Y., E-mail: xiangyu.hu@tum.de; Adams, Nikolaus A.
The standard smoothed particle hydrodynamics (SPH) method suffers from tensile instability. In fluid-dynamics simulations this instability leads to particle clumping and void regions when negative pressure occurs. In solid-dynamics simulations, it results in unphysical structure fragmentation. In this work the transport-velocity formulation of Adami et al. (2013) is generalized for providing a solution of this long-standing problem. Other than imposing a global background pressure, a variable background pressure is used to modify the particle transport velocity and eliminate the tensile instability completely. Furthermore, such a modification is localized by defining a shortened smoothing length. The generalized formulation is suitable formore » fluid and solid materials with and without free surfaces. The results of extensive numerical tests on both fluid and solid dynamics problems indicate that the new method provides a unified approach for multi-physics SPH simulations.« less
Multiphysics Object Oriented Simulation Environment
DOE Office of Scientific and Technical Information (OSTI.GOV)
The Multiphysics Object Oriented Simulation Environment (MOOSE) software library developed at Idaho National Laboratory is a tool. MOOSE, like other tools, doesn't actually complete a task. Instead, MOOSE seeks to reduce the effort required to create engineering simulation applications. MOOSE itself is a software library: a blank canvas upon which you write equations and then MOOSE can help you solve them. MOOSE is comparable to a spreadsheet application. A spreadsheet, by itself, doesn't do anything. Only once equations are entered into it will a spreadsheet application compute anything. Such is the same for MOOSE. An engineer or scientist can utilizemore » the equation solvers within MOOSE to solve equations related to their area of study. For instance, a geomechanical scientist can input equations related to water flow in underground reservoirs and MOOSE can solve those equations to give the scientist an idea of how water could move over time. An engineer might input equations related to the forces in steel beams in order to understand the load bearing capacity of a bridge. Because MOOSE is a blank canvas it can be useful in many scientific and engineering pursuits.« less
Rausch, Felix; Schicht, Martin; Bräuer, Lars; Paulsen, Friedrich; Brandt, Wolfgang
2014-11-01
Surfactant proteins are well known from the human lung where they are responsible for the stability and flexibility of the pulmonary surfactant system. They are able to influence the surface tension of the gas-liquid interface specifically by directly interacting with single lipids. This work describes the generation of reliable protein structure models to support the experimental characterization of two novel putative surfactant proteins called SP-G and SP-H. The obtained protein models were complemented by predicted posttranslational modifications and placed in a lipid model system mimicking the pulmonary surface. Molecular dynamics simulations of these protein-lipid systems showed the stability of the protein models and the formation of interactions between protein surface and lipid head groups on an atomic scale. Thereby, interaction interface and strength seem to be dependent on orientation and posttranslational modification of the protein. The here presented modeling was fundamental for experimental localization studies and the simulations showed that SP-G and SP-H are theoretically able to interact with lipid systems and thus are members of the surfactant protein family.
MODELLING OF FUEL BEHAVIOUR DURING LOSS-OF-COOLANT ACCIDENTS USING THE BISON CODE
DOE Office of Scientific and Technical Information (OSTI.GOV)
Pastore, G.; Novascone, S. R.; Williamson, R. L.
2015-09-01
This work presents recent developments to extend the BISON code to enable fuel performance analysis during LOCAs. This newly developed capability accounts for the main physical phenomena involved, as well as the interactions among them and with the global fuel rod thermo-mechanical analysis. Specifically, new multiphysics models are incorporated in the code to describe (1) transient fission gas behaviour, (2) rapid steam-cladding oxidation, (3) Zircaloy solid-solid phase transition, (4) hydrogen generation and transport through the cladding, and (5) Zircaloy high-temperature non-linear mechanical behaviour and failure. Basic model characteristics are described, and a demonstration BISON analysis of a LWR fuel rodmore » undergoing a LOCA accident is presented. Also, as a first step of validation, the code with the new capability is applied to the simulation of experiments investigating cladding behaviour under LOCA conditions. The comparison of the results with the available experimental data of cladding failure due to burst is presented.« less
High frequency electromagnetism, heat transfer and fluid flow coupling in ANSYS multiphysics.
Sabliov, Cristina M; Salvi, Deepti A; Boldor, Dorin
2007-01-01
The goal of this study was to numerically predict the temperature of a liquid product heated in a continuous-flow focused microwave system by coupling high frequency electromagnetism, heat transfer, and fluid flow in ANSYS Multiphysics. The developed model was used to determine the temperature change in water processed in a 915 MHz microwave unit, under steady-state conditions. The influence of the flow rates on the temperature distribution in the liquid was assessed. Results showed that the average temperature of water increased from 25 degrees C to 34 degrees C at 2 l/min, and to 42 degrees C at 1 l/min. The highest temperature regions were found in the liquid near the center of the tube, followed by progressively lower temperature regions as the radial distance from the center increased, and finally followed by a slightly higher temperature region near the tube's wall corresponding to the energy distribution given by the Mathieu function. The energy distribution resulted in a similar temperature pattern, with the highest temperatures close to the center of the tube and lower at the walls. The presented ANSYS Multiphysics model can be easily improved to account for complex boundary conditions, phase change, temperature dependent properties, and non-Newtonian flows, which makes for an objective of future studies.
NASA Astrophysics Data System (ADS)
Konishi, Toshifumi; Yamane, Daisuke; Matsushima, Takaaki; Masu, Kazuya; Machida, Katsuyuki; Toshiyoshi, Hiroshi
2014-01-01
This paper reports the design and evaluation results of a capacitive CMOS-MEMS sensor that consists of the proposed sensor circuit and a capacitive MEMS device implemented on the circuit. To design a capacitive CMOS-MEMS sensor, a multi-physics simulation of the electromechanical behavior of both the MEMS structure and the sensing LSI was carried out simultaneously. In order to verify the validity of the design, we applied the capacitive CMOS-MEMS sensor to a MEMS accelerometer implemented by the post-CMOS process onto a 0.35-µm CMOS circuit. The experimental results of the CMOS-MEMS accelerometer exhibited good agreement with the simulation results within the input acceleration range between 0.5 and 6 G (1 G = 9.8 m/s2), corresponding to the output voltages between 908.6 and 915.4 mV, respectively. Therefore, we have confirmed that our capacitive CMOS-MEMS sensor and the multi-physics simulation will be beneficial method to realize integrated CMOS-MEMS technology.
NASA Astrophysics Data System (ADS)
Li, Gangqiang; Zhu, Zheng H.; Ruel, Stephane; Meguid, S. A.
2017-08-01
This paper developed a new multiphysics finite element method for the elastodynamic analysis of space debris deorbit by a bare flexible electrodynamic tether. Orbital motion limited theory and dynamics of flexible electrodynamic tethers are discretized by the finite element method, where the motional electric field is variant along the tether and coupled with tether deflection and motion. Accordingly, the electrical current and potential bias profiles of tether are solved together with the tether dynamics by the nodal position finite element method. The newly proposed multiphysics finite element method is applied to analyze the deorbit dynamics of space debris by electrodynamic tethers with a two-stage energy control strategy to ensure an efficient and stable deorbit process. Numerical simulations are conducted to study the coupled effect between the motional electric field and the tether dynamics. The results reveal that the coupling effect has a significant influence on the tether stability and the deorbit performance. It cannot be ignored when the libration and deflection of the tether are significant.
Modeling of the thermal comfort in vehicles using COMSOL multiphysics
NASA Astrophysics Data System (ADS)
Gavrila, Camelia; Vartires, Andreea
2016-12-01
The environmental quality in vehicles is a very important aspect of building design and evaluation of the influence of the thermal comfort inside the car for ensuring a safe trip. The aim of this paper is to modeling and simulating the thermal comfort inside the vehicles, using COMSOL Multiphysics program, for different ventilation grilles. The objective will be the implementing innovative air diffusion grilles in a prototype vehicle. The idea behind this goal is to introduce air diffusers with a special geometry allowing improving mixing between the hot or the cold conditioned air introduced in the cockpit and the ambient.
Multiscale Multiphysics and Multidomain Models I: Basic Theory
Wei, Guo-Wei
2013-01-01
This work extends our earlier two-domain formulation of a differential geometry based multiscale paradigm into a multidomain theory, which endows us the ability to simultaneously accommodate multiphysical descriptions of aqueous chemical, physical and biological systems, such as fuel cells, solar cells, nanofluidics, ion channels, viruses, RNA polymerases, molecular motors and large macromolecular complexes. The essential idea is to make use of the differential geometry theory of surfaces as a natural means to geometrically separate the macroscopic domain of solvent from the microscopic domain of solute, and dynamically couple continuum and discrete descriptions. Our main strategy is to construct energy functionals to put on an equal footing of multiphysics, including polar (i.e., electrostatic) solvation, nonpolar solvation, chemical potential, quantum mechanics, fluid mechanics, molecular mechanics, coarse grained dynamics and elastic dynamics. The variational principle is applied to the energy functionals to derive desirable governing equations, such as multidomain Laplace-Beltrami (LB) equations for macromolecular morphologies, multidomain Poisson-Boltzmann (PB) equation or Poisson equation for electrostatic potential, generalized Nernst-Planck (NP) equations for the dynamics of charged solvent species, generalized Navier-Stokes (NS) equation for fluid dynamics, generalized Newton's equations for molecular dynamics (MD) or coarse-grained dynamics and equation of motion for elastic dynamics. Unlike the classical PB equation, our PB equation is an integral-differential equation due to solvent-solute interactions. To illustrate the proposed formalism, we have explicitly constructed three models, a multidomain solvation model, a multidomain charge transport model and a multidomain chemo-electro-fluid-MD-elastic model. Each solute domain is equipped with distinct surface tension, pressure, dielectric function, and charge density distribution. In addition to long
Multiscale Multiphysics and Multidomain Models I: Basic Theory.
Wei, Guo-Wei
2013-12-01
This work extends our earlier two-domain formulation of a differential geometry based multiscale paradigm into a multidomain theory, which endows us the ability to simultaneously accommodate multiphysical descriptions of aqueous chemical, physical and biological systems, such as fuel cells, solar cells, nanofluidics, ion channels, viruses, RNA polymerases, molecular motors and large macromolecular complexes. The essential idea is to make use of the differential geometry theory of surfaces as a natural means to geometrically separate the macroscopic domain of solvent from the microscopic domain of solute, and dynamically couple continuum and discrete descriptions. Our main strategy is to construct energy functionals to put on an equal footing of multiphysics, including polar (i.e., electrostatic) solvation, nonpolar solvation, chemical potential, quantum mechanics, fluid mechanics, molecular mechanics, coarse grained dynamics and elastic dynamics. The variational principle is applied to the energy functionals to derive desirable governing equations, such as multidomain Laplace-Beltrami (LB) equations for macromolecular morphologies, multidomain Poisson-Boltzmann (PB) equation or Poisson equation for electrostatic potential, generalized Nernst-Planck (NP) equations for the dynamics of charged solvent species, generalized Navier-Stokes (NS) equation for fluid dynamics, generalized Newton's equations for molecular dynamics (MD) or coarse-grained dynamics and equation of motion for elastic dynamics. Unlike the classical PB equation, our PB equation is an integral-differential equation due to solvent-solute interactions. To illustrate the proposed formalism, we have explicitly constructed three models, a multidomain solvation model, a multidomain charge transport model and a multidomain chemo-electro-fluid-MD-elastic model. Each solute domain is equipped with distinct surface tension, pressure, dielectric function, and charge density distribution. In addition to long
Development of the US3D Code for Advanced Compressible and Reacting Flow Simulations
NASA Technical Reports Server (NTRS)
Candler, Graham V.; Johnson, Heath B.; Nompelis, Ioannis; Subbareddy, Pramod K.; Drayna, Travis W.; Gidzak, Vladimyr; Barnhardt, Michael D.
2015-01-01
Aerothermodynamics and hypersonic flows involve complex multi-disciplinary physics, including finite-rate gas-phase kinetics, finite-rate internal energy relaxation, gas-surface interactions with finite-rate oxidation and sublimation, transition to turbulence, large-scale unsteadiness, shock-boundary layer interactions, fluid-structure interactions, and thermal protection system ablation and thermal response. Many of the flows have a large range of length and time scales, requiring large computational grids, implicit time integration, and large solution run times. The University of Minnesota NASA US3D code was designed for the simulation of these complex, highly-coupled flows. It has many of the features of the well-established DPLR code, but uses unstructured grids and has many advanced numerical capabilities and physical models for multi-physics problems. The main capabilities of the code are described, the physical modeling approaches are discussed, the different types of numerical flux functions and time integration approaches are outlined, and the parallelization strategy is overviewed. Comparisons between US3D and the NASA DPLR code are presented, and several advanced simulations are presented to illustrate some of novel features of the code.
NASA Astrophysics Data System (ADS)
Zheng, Jiajia; Li, Yancheng; Li, Zhaochun; Wang, Jiong
2015-10-01
This paper presents multi-physics modeling of an MR absorber considering the magnetic hysteresis to capture the nonlinear relationship between the applied current and the generated force under impact loading. The magnetic field, temperature field, and fluid dynamics are represented by the Maxwell equations, conjugate heat transfer equations, and Navier-Stokes equations. These fields are coupled through the apparent viscosity and the magnetic force, both of which in turn depend on the magnetic flux density and the temperature. Based on a parametric study, an inverse Jiles-Atherton hysteresis model is used and implemented for the magnetic field simulation. The temperature rise of the MR fluid in the annular gap caused by core loss (i.e. eddy current loss and hysteresis loss) and fluid motion is computed to investigate the current-force behavior. A group of impulsive tests was performed for the manufactured MR absorber with step exciting currents. The numerical and experimental results showed good agreement, which validates the effectiveness of the proposed multi-physics FEA model.
3D multiphysics modeling of superconducting cavities with a massively parallel simulation suite
Kononenko, Oleksiy; Adolphsen, Chris; Li, Zenghai; ...
2017-10-10
Radiofrequency cavities based on superconducting technology are widely used in particle accelerators for various applications. The cavities usually have high quality factors and hence narrow bandwidths, so the field stability is sensitive to detuning from the Lorentz force and external loads, including vibrations and helium pressure variations. If not properly controlled, the detuning can result in a serious performance degradation of a superconducting accelerator, so an understanding of the underlying detuning mechanisms can be very helpful. Recent advances in the simulation suite ace3p have enabled realistic multiphysics characterization of such complex accelerator systems on supercomputers. In this paper, we presentmore » the new capabilities in ace3p for large-scale 3D multiphysics modeling of superconducting cavities, in particular, a parallel eigensolver for determining mechanical resonances, a parallel harmonic response solver to calculate the response of a cavity to external vibrations, and a numerical procedure to decompose mechanical loads, such as from the Lorentz force or piezoactuators, into the corresponding mechanical modes. These capabilities have been used to do an extensive rf-mechanical analysis of dressed TESLA-type superconducting cavities. Furthermore, the simulation results and their implications for the operational stability of the Linac Coherent Light Source-II are discussed.« less
3D multiphysics modeling of superconducting cavities with a massively parallel simulation suite
NASA Astrophysics Data System (ADS)
Kononenko, Oleksiy; Adolphsen, Chris; Li, Zenghai; Ng, Cho-Kuen; Rivetta, Claudio
2017-10-01
Radiofrequency cavities based on superconducting technology are widely used in particle accelerators for various applications. The cavities usually have high quality factors and hence narrow bandwidths, so the field stability is sensitive to detuning from the Lorentz force and external loads, including vibrations and helium pressure variations. If not properly controlled, the detuning can result in a serious performance degradation of a superconducting accelerator, so an understanding of the underlying detuning mechanisms can be very helpful. Recent advances in the simulation suite ace3p have enabled realistic multiphysics characterization of such complex accelerator systems on supercomputers. In this paper, we present the new capabilities in ace3p for large-scale 3D multiphysics modeling of superconducting cavities, in particular, a parallel eigensolver for determining mechanical resonances, a parallel harmonic response solver to calculate the response of a cavity to external vibrations, and a numerical procedure to decompose mechanical loads, such as from the Lorentz force or piezoactuators, into the corresponding mechanical modes. These capabilities have been used to do an extensive rf-mechanical analysis of dressed TESLA-type superconducting cavities. The simulation results and their implications for the operational stability of the Linac Coherent Light Source-II are discussed.
3D multiphysics modeling of superconducting cavities with a massively parallel simulation suite
DOE Office of Scientific and Technical Information (OSTI.GOV)
Kononenko, Oleksiy; Adolphsen, Chris; Li, Zenghai
Radiofrequency cavities based on superconducting technology are widely used in particle accelerators for various applications. The cavities usually have high quality factors and hence narrow bandwidths, so the field stability is sensitive to detuning from the Lorentz force and external loads, including vibrations and helium pressure variations. If not properly controlled, the detuning can result in a serious performance degradation of a superconducting accelerator, so an understanding of the underlying detuning mechanisms can be very helpful. Recent advances in the simulation suite ace3p have enabled realistic multiphysics characterization of such complex accelerator systems on supercomputers. In this paper, we presentmore » the new capabilities in ace3p for large-scale 3D multiphysics modeling of superconducting cavities, in particular, a parallel eigensolver for determining mechanical resonances, a parallel harmonic response solver to calculate the response of a cavity to external vibrations, and a numerical procedure to decompose mechanical loads, such as from the Lorentz force or piezoactuators, into the corresponding mechanical modes. These capabilities have been used to do an extensive rf-mechanical analysis of dressed TESLA-type superconducting cavities. Furthermore, the simulation results and their implications for the operational stability of the Linac Coherent Light Source-II are discussed.« less
AX-GADGET: a new code for cosmological simulations of Fuzzy Dark Matter and Axion models
NASA Astrophysics Data System (ADS)
Nori, Matteo; Baldi, Marco
2018-05-01
We present a new module of the parallel N-Body code P-GADGET3 for cosmological simulations of light bosonic non-thermal dark matter, often referred as Fuzzy Dark Matter (FDM). The dynamics of the FDM features a highly non-linear Quantum Potential (QP) that suppresses the growth of structures at small scales. Most of the previous attempts of FDM simulations either evolved suppressed initial conditions, completely neglecting the dynamical effects of QP throughout cosmic evolution, or resorted to numerically challenging full-wave solvers. The code provides an interesting alternative, following the FDM evolution without impairing the overall performance. This is done by computing the QP acceleration through the Smoothed Particle Hydrodynamics (SPH) routines, with improved schemes to ensure precise and stable derivatives. As an extension of the P-GADGET3 code, it inherits all the additional physics modules implemented up to date, opening a wide range of possibilities to constrain FDM models and explore its degeneracies with other physical phenomena. Simulations are compared with analytical predictions and results of other codes, validating the QP as a crucial player in structure formation at small scales.
NASA Astrophysics Data System (ADS)
Massimino, G.; Colombo, A.; D'Alessandro, L.; Procopio, F.; Ardito, R.; Ferrera, M.; Corigliano, A.
2018-05-01
In this paper a complete multiphysics modelling via the finite element method (FEM) of an air-coupled array of piezoelectric micromachined ultrasonic transducers (PMUT) and its experimental validation are presented. Two numerical models are described for the single transducer, axisymmetric and 3D, with the following features: the presence of fabrication induced residual stresses, which determine a non-linear initial deformed configuration of the diaphragm and a substantial fundamental mode frequency shift; the multiple coupling between different physics, namely electro-mechanical coupling for the piezo-electric model, thermo-acoustic-structural interaction and thermo-acoustic-pressure interaction for the waves propagation in the surrounding fluid. The model for the single transducer is enhanced considering the full set of PMUTs belonging to the silicon dye in a 4 × 4 array configuration. The results of the numerical multiphysics models are compared with experimental ones in terms of the initial static pre-deflection, of the diaphragm central point spectrum and of the sound intensity at 3.5 cm on the vertical direction along the axis of the diaphragm.
Multiscale Multiphysics Developments for Accident Tolerant Fuel Concepts
DOE Office of Scientific and Technical Information (OSTI.GOV)
Gamble, K. A.; Hales, J. D.; Yu, J.
2015-09-01
U 3Si 2 and iron-chromium-aluminum (Fe-Cr-Al) alloys are two of many proposed accident-tolerant fuel concepts for the fuel and cladding, respectively. The behavior of these materials under normal operating and accident reactor conditions is not well known. As part of the Department of Energy’s Accident Tolerant Fuel High Impact Problem program significant work has been conducted to investigate the U 3Si 2 and FeCrAl behavior under reactor conditions. This report presents the multiscale and multiphysics effort completed in fiscal year 2015. The report is split into four major categories including Density Functional Theory Developments, Molecular Dynamics Developments, Mesoscale Developments, andmore » Engineering Scale Developments. The work shown here is a compilation of a collaborative effort between Idaho National Laboratory, Los Alamos National Laboratory, Argonne National Laboratory and Anatech Corp.« less
Multi-physics optimization of three-dimensional microvascular polymeric components
NASA Astrophysics Data System (ADS)
Aragón, Alejandro M.; Saksena, Rajat; Kozola, Brian D.; Geubelle, Philippe H.; Christensen, Kenneth T.; White, Scott R.
2013-01-01
This work discusses the computational design of microvascular polymeric materials, which aim at mimicking the behavior found in some living organisms that contain a vascular system. The optimization of the topology of the embedded three-dimensional microvascular network is carried out by coupling a multi-objective constrained genetic algorithm with a finite-element based physics solver, the latter validated through experiments. The optimization is carried out on multiple conflicting objective functions, namely the void volume fraction left by the network, the energy required to drive the fluid through the network and the maximum temperature when the material is subjected to thermal loads. The methodology presented in this work results in a viable alternative for the multi-physics optimization of these materials for active-cooling applications.
NREL Multiphysics Modeling Tools and ISC Device for Designing Safer Li-Ion Batteries
DOE Office of Scientific and Technical Information (OSTI.GOV)
Pesaran, Ahmad A.; Yang, Chuanbo
2016-03-24
The National Renewable Energy Laboratory has developed a portfolio of multiphysics modeling tools to aid battery designers better understand the response of lithium ion batteries to abusive conditions. We will discuss this portfolio, which includes coupled electrical, thermal, chemical, electrochemical, and mechanical modeling. These models can simulate the response of a cell to overheating, overcharge, mechanical deformation, nail penetration, and internal short circuit. Cell-to-cell thermal propagation modeling will be discussed.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Nelson, Andrew F.; Wetzstein, M.; Naab, T.
2009-10-01
We continue our presentation of VINE. In this paper, we begin with a description of relevant architectural properties of the serial and shared memory parallel computers on which VINE is intended to run, and describe their influences on the design of the code itself. We continue with a detailed description of a number of optimizations made to the layout of the particle data in memory and to our implementation of a binary tree used to access that data for use in gravitational force calculations and searches for smoothed particle hydrodynamics (SPH) neighbor particles. We describe the modifications to the codemore » necessary to obtain forces efficiently from special purpose 'GRAPE' hardware, the interfaces required to allow transparent substitution of those forces in the code instead of those obtained from the tree, and the modifications necessary to use both tree and GRAPE together as a fused GRAPE/tree combination. We conclude with an extensive series of performance tests, which demonstrate that the code can be run efficiently and without modification in serial on small workstations or in parallel using the OpenMP compiler directives on large-scale, shared memory parallel machines. We analyze the effects of the code optimizations and estimate that they improve its overall performance by more than an order of magnitude over that obtained by many other tree codes. Scaled parallel performance of the gravity and SPH calculations, together the most costly components of most simulations, is nearly linear up to at least 120 processors on moderate sized test problems using the Origin 3000 architecture, and to the maximum machine sizes available to us on several other architectures. At similar accuracy, performance of VINE, used in GRAPE-tree mode, is approximately a factor 2 slower than that of VINE, used in host-only mode. Further optimizations of the GRAPE/host communications could improve the speed by as much as a factor of 3, but have not yet been implemented in VINE
Eichhöfer, Andreas; Lebedkin, Sergei
2018-01-16
Reactions of [Mn{N(SiMe 3 ) 2 } 2 ] 2 with 2.1 equiv of RSH, R = Ph or Mes = C 6 H 2 -2,4,6-(CH 3 ) 3 , yield compounds of the formal composition "Mn(SR) 2 ". Single-crystal X-ray diffraction reveals that ∞ 1 [Mn(SMes) 2 ] forms one-dimensional chains in the crystal via μ 2 -SMes bridges, whereas ∞ 3 [Mn 4 (SPh) 8 ] comprises a three-dimensional network in which adamantanoid cages composed of four Mn atoms and six μ 2 -bridging SPh ligands are connected in three dimensions by doubly bridging SPh ligands. Thermogravimetric analysis and powder diffractometry indicate an reversible uptake of solvent molecules (tetrahydrofuran) into the channels of ∞ 1 [Mn(SMes) 2 ]. Magnetic measurements reveal antiferromagnetic coupling for both compounds with J = -8.2 cm -1 ( ∞ 1 [Mn(SMes) 2 ]) and -10.0 cm -1 ( ∞ 3 [Mn 4 (SPh) 8 ]), respectively. Their optical absorption and photoluminescence (PL) excitation spectra display characteristic d-d bands of Mn 2+ ions in the visible spectral region. Both compounds emit bright phosphorescence at ∼800 nm at low temperatures (<100 K). However, only ∞ 1 [Mn(SMes) 2 ] retains a moderately intense emission at ambient temperature (with a quantum yield of 1.2%). Similar PL properties are also found for the related selenolate complexes ∞ 1 [Mn(SeR) 2 ] (R = Ph, Mes).
Almog, Orna; González, Ana; Godin, Noa; de Leeuw, Marina; Mekel, Marlene J; Klein, Daniela; Braun, Sergei; Shoham, Gil; Walter, Richard L
2009-02-01
We determine and compare the crystal structure of two proteases belonging to the subtilisin superfamily: S41, a cold-adapted serine protease produced by Antarctic bacilli, at 1.4 A resolution and Sph, a mesophilic serine protease produced by Bacillus sphaericus, at 0.8 A resolution. The purpose of this comparison was to find out whether multiple calcium ion binding is a molecular factor responsible for the adaptation of S41 to extreme low temperatures. We find that these two subtilisins have the same subtilisin fold with a root mean square between the two structures of 0.54 A. The final models for S41 and Sph include a calcium-loaded state of five ions bound to each of these two subtilisin molecules. None of these calcium-binding sites correlate with the high affinity known binding site (site A) found for other subtilisins. Structural analysis of the five calcium-binding sites found in these two crystal structures indicate that three of the binding sites have two side chains of an acidic residue coordinating the calcium ion, whereas the other two binding sites have either a main-chain carbonyl, or only one acidic residue side chain coordinating the calcium ion. Thus, we conclude that three of the sites are of high affinity toward calcium ions, whereas the other two are of low affinity. Because Sph is a mesophilic subtilisin and S41 is a psychrophilic subtilisin, but both crystal structures were found to bind five calcium ions, we suggest that multiple calcium ion binding is not responsible for the adaptation of S41 to low temperatures. Copyright 2008 Wiley-Liss, Inc.
Local Group dSph radio survey with ATCA (I): observations and background sources
NASA Astrophysics Data System (ADS)
Regis, Marco; Richter, Laura; Colafrancesco, Sergio; Massardi, Marcella; de Blok, W. J. G.; Profumo, Stefano; Orford, Nicola
2015-04-01
Dwarf spheroidal (dSph) galaxies are key objects in near-field cosmology, especially in connection to the study of galaxy formation and evolution at small scales. In addition, dSphs are optimal targets to investigate the nature of dark matter. However, while we begin to have deep optical photometric observations of the stellar population in these objects, little is known so far about their diffuse emission at any observing frequency, and hence on thermal and non-thermal plasma possibly residing within dSphs. In this paper, we present deep radio observations of six local dSphs performed with the Australia Telescope Compact Array (ATCA) at 16 cm wavelength. We mosaicked a region of radius of about 1 deg around three `classical' dSphs, Carina, Fornax, and Sculptor, and of about half of degree around three `ultrafaint' dSphs, BootesII, Segue2, and Hercules. The rms noise level is below 0.05 mJy for all the maps. The restoring beams full width at half-maximum ranged from 4.2 arcsec × 2.5 arcsec to 30.0 arcsec × 2.1 arcsec in the most elongated case. A catalogue including the 1392 sources detected in the six dSph fields is reported. The main properties of the background sources are discussed, with positions and fluxes of brightest objects compared with the FIRST, NVSS, and SUMSS observations of the same fields. The observed population of radio emitters in these fields is dominated by synchrotron sources. We compute the associated source number counts at 2 GHz down to fluxes of 0.25 mJy, which prove to be in agreement with AGN count models.
The chemical abundances of the stellar populations in the Leo I and II dSph galaxies
NASA Astrophysics Data System (ADS)
Bosler, Tammy L.; Smecker-Hane, Tammy A.; Stetson, Peter B.
2007-06-01
We have obtained calcium abundances and radial velocities for 102 red giant branch (RGB) stars in the Leo I dwarf spheroidal galaxy (dSph) and 74 RGB stars in the Leo II dSph using the low-resolution spectrograph (LRIS) on the Keck I 10-m telescope. We report on the calcium abundances [Ca/H] derived from the strengths of the CaII triplet absorption lines at 8498, 8542 and 8662 Å in the stellar spectra using a new empirical CaII triplet calibration to [Ca/H]. The two galaxies have different average [Ca/H] values of -1.34 +/- 0.02 for Leo I and -1.65 +/- 0.02 for Leo II with intrinsic abundance dispersions of 1.2 and 1.0 dex, respectively. The typical random and total errors in derived abundances are 0.10 and 0.17 dex per star. For comparison to the existing literature, we also converted our CaII measurements to [Fe/H] on the scale of Carretta and Gratton (1997) though we discuss why this may not be the best determinant of metallicity; Leo I has a mean [Fe/H] = -1.34 and Leo II has a mean [Fe/H] = -1.59. The metallicity distribution function of Leo I is approximately Gaussian in shape with an excess at the metal-rich end, while that of Leo II shows an abrupt cut-off at the metal-rich end. The lower mean metallicity of Leo II is consistent with the fact that it has a lower luminosity, hence lower the total mass than Leo I; thus, the evolution of Leo II may have been affected more by mass lost in galactic winds. Our direct and independent measurement of the metallicity distributions in these dSph will allow a more accurate star-formation histories to be derived from future analysis of their colour-magnitude diagrams(CMDs). Data presented herein were obtained at the W.M. Keck Observatory, which is operated as a scientific partnership among the California Institute of Technology, the University of California and the National Aeronautics and Space Administration. The Observatory was made possible by the generous financial support of the W. M. Keck Foundation. E
Numerical simulation of wave-current interaction using the SPH method
NASA Astrophysics Data System (ADS)
He, Ming; Gao, Xi-feng; Xu, Wan-hai
2018-05-01
In this paper, the smoothed particle hydrodynamics (SPH) method is used to build a numerical wave-current tank (NWCT). The wave is generated by using a piston-type wave generator and is absorbed by using a sponge layer. The uniform current field is generated by simultaneously imposing the directional velocity and hydrostatic pressure in both inflow and outflow regions set below the NWCT. Particle cyclic boundaries are also implemented for recycling the Lagrangian fluid particles. Furthermore, to shorten the time to reach a steady state, a temporary rigid-lid treatment for the water surface is proposed. It turns out to be very effective for weakening the undesired oscillatory flow at the beginning stage of the current generation. The calculated water surface elevation and horizontal-velocity profile are validated against the available experimental data. Satisfactory agreements are obtained, demonstrating the good capability of the NWCT.
Solid Rocket Motor Combustion Instability Modeling in COMSOL Multiphysics
NASA Technical Reports Server (NTRS)
Fischbach, Sean R.
2015-01-01
Combustion instability modeling of Solid Rocket Motors (SRM) remains a topic of active research. Many rockets display violent fluctuations in pressure, velocity, and temperature originating from the complex interactions between the combustion process, acoustics, and steady-state gas dynamics. Recent advances in defining the energy transport of disturbances within steady flow-fields have been applied by combustion stability modelers to improve the analysis framework [1, 2, 3]. Employing this more accurate global energy balance requires a higher fidelity model of the SRM flow-field and acoustic mode shapes. The current industry standard analysis tool utilizes a one dimensional analysis of the time dependent fluid dynamics along with a quasi-three dimensional propellant grain regression model to determine the SRM ballistics. The code then couples with another application that calculates the eigenvalues of the one dimensional homogenous wave equation. The mean flow parameters and acoustic normal modes are coupled to evaluate the stability theory developed and popularized by Culick [4, 5]. The assumption of a linear, non-dissipative wave in a quiescent fluid remains valid while acoustic amplitudes are small and local gas velocities stay below Mach 0.2. The current study employs the COMSOL multiphysics finite element framework to model the steady flow-field parameters and acoustic normal modes of a generic SRM. The study requires one way coupling of the CFD High Mach Number Flow (HMNF) and mathematics module. The HMNF module evaluates the gas flow inside of a SRM using St. Robert's law to model the solid propellant burn rate, no slip boundary conditions, and the hybrid outflow condition. Results from the HMNF model are verified by comparing the pertinent ballistics parameters with the industry standard code outputs (i.e. pressure drop, thrust, ect.). These results are then used by the coefficient form of the mathematics module to determine the complex eigenvalues of the
Multiscale multiphysics and multidomain models—Flexibility and rigidity
DOE Office of Scientific and Technical Information (OSTI.GOV)
Xia, Kelin; Opron, Kristopher; Wei, Guo-Wei, E-mail: wei@math.msu.edu
The emerging complexity of large macromolecules has led to challenges in their full scale theoretical description and computer simulation. Multiscale multiphysics and multidomain models have been introduced to reduce the number of degrees of freedom while maintaining modeling accuracy and achieving computational efficiency. A total energy functional is constructed to put energies for polar and nonpolar solvation, chemical potential, fluid flow, molecular mechanics, and elastic dynamics on an equal footing. The variational principle is utilized to derive coupled governing equations for the above mentioned multiphysical descriptions. Among these governing equations is the Poisson-Boltzmann equation which describes continuum electrostatics with atomicmore » charges. The present work introduces the theory of continuum elasticity with atomic rigidity (CEWAR). The essence of CEWAR is to formulate the shear modulus as a continuous function of atomic rigidity. As a result, the dynamics complexity of a macromolecular system is separated from its static complexity so that the more time-consuming dynamics is handled with continuum elasticity theory, while the less time-consuming static analysis is pursued with atomic approaches. We propose a simple method, flexibility-rigidity index (FRI), to analyze macromolecular flexibility and rigidity in atomic detail. The construction of FRI relies on the fundamental assumption that protein functions, such as flexibility, rigidity, and energy, are entirely determined by the structure of the protein and its environment, although the structure is in turn determined by all the interactions. As such, the FRI measures the topological connectivity of protein atoms or residues and characterizes the geometric compactness of the protein structure. As a consequence, the FRI does not resort to the interaction Hamiltonian and bypasses matrix diagonalization, which underpins most other flexibility analysis methods. FRI's computational complexity
Integral Full Core Multi-Physics PWR Benchmark with Measured Data
DOE Office of Scientific and Technical Information (OSTI.GOV)
Forget, Benoit; Smith, Kord; Kumar, Shikhar
In recent years, the importance of modeling and simulation has been highlighted extensively in the DOE research portfolio with concrete examples in nuclear engineering with the CASL and NEAMS programs. These research efforts and similar efforts worldwide aim at the development of high-fidelity multi-physics analysis tools for the simulation of current and next-generation nuclear power reactors. Like all analysis tools, verification and validation is essential to guarantee proper functioning of the software and methods employed. The current approach relies mainly on the validation of single physic phenomena (e.g. critical experiment, flow loops, etc.) and there is a lack of relevantmore » multiphysics benchmark measurements that are necessary to validate high-fidelity methods being developed today. This work introduces a new multi-cycle full-core Pressurized Water Reactor (PWR) depletion benchmark based on two operational cycles of a commercial nuclear power plant that provides a detailed description of fuel assemblies, burnable absorbers, in-core fission detectors, core loading and re-loading patterns. This benchmark enables analysts to develop extremely detailed reactor core models that can be used for testing and validation of coupled neutron transport, thermal-hydraulics, and fuel isotopic depletion. The benchmark also provides measured reactor data for Hot Zero Power (HZP) physics tests, boron letdown curves, and three-dimensional in-core flux maps from 58 instrumented assemblies. The benchmark description is now available online and has been used by many groups. However, much work remains to be done on the quantification of uncertainties and modeling sensitivities. This work aims to address these deficiencies and make this benchmark a true non-proprietary international benchmark for the validation of high-fidelity tools. This report details the BEAVRS uncertainty quantification for the first two cycle of operations and serves as the final report of the
NASA Technical Reports Server (NTRS)
Wang, Ten-See; Foote, John; Litchford, Ron
2006-01-01
The objective of this effort is to perform design analyses for a non-nuclear hot-hydrogen materials tester, as a first step towards developing efficient and accurate multiphysics, thermo-fluid computational methodology to predict environments for hypothetical solid-core, nuclear thermal engine thrust chamber design and analysis. The computational methodology is based on a multidimensional, finite-volume, turbulent, chemically reacting, thermally radiating, unstructured-grid, and pressure-based formulation. The multiphysics invoked in this study include hydrogen dissociation kinetics and thermodynamics, turbulent flow, convective, and thermal radiative heat transfers. The goals of the design analyses are to maintain maximum hot-hydrogen jet impingement energy and to minimize chamber wall heating. The results of analyses on three test fixture configurations and the rationale for final selection are presented. The interrogation of physics revealed that reactions of hydrogen dissociation and recombination are highly correlated with local temperature and are necessary for accurate prediction of the hot-hydrogen jet temperature.
Xu, Chao; Hedin, Niklas; Shi, Hua-Tian; Xin, ZhiFeng; Zhang, Qian-Feng
2015-04-14
Chalcogenolate clusters can be interlinked with organic linkers into semiconducting coordination polymers with photocatalytic properties. Here, discrete clusters of Cd8S(SPh)14(DMF)3 were interlinked with 4,4'-bipyridine into a one dimensional coordination polymer of [Cd8S(SPh)14(DMF)(bpy)]n with helical chains. A stepwise mechanism for the assembly of the coordination polymer in DMF was revealed by an ex situ dynamic light scattering study. The cluster was electrostatically neutral and showed a penta-supertetrahedral structure. During the assembly each cluster was interlinked with two 4,4'-bipyridine molecules, which replaced the two terminal DMF molecules of the clusters. In their solid-state forms, the cluster and the coordination polymer were semiconductors with wide band gaps of 3.08 and 2.80 ev. They photocatalytically degraded rhodamine B and methylene blue in aqueous solutions. The moderate conditions used for the synthesis could allow for further in situ studies of the reaction-assembly of related clusters and coordination polymers.
Harrison, Simon M; Cleary, Paul W; Sinnott, Matthew D
2018-05-18
The stomach is a critical organ for food digestion but it is not well understood how it operates, either when healthy or when dysfunction occurs. Stomach function depends on the timing and amplitude of wall contractions, the fill level and the type of gastric content. Using a coupled biomechanical-Smoothed Particle Hydrodynamics (B-SPH) model, we investigate how gastric discharge is affected by the contraction behaviour of the stomach wall and the viscosity of the content. The results of the model provide new insights into how the content viscosity and the number of compression waves down the length of the stomach affect the mixing within and the discharge rate of the content exiting from the stomach to the duodenum. This investigation shows that the B-SPH model is capable of simulating complicated stomach behaviour. The rate of gastric emptying is found to increase with a smaller period in between contractile waves and to have a nonlinear relationship with content viscosity. Increased resistance to flow into the duodenum is also shown to reduce the rate of emptying. The degree of gastric mixing is found to be insensitive to changes in the period between contractile waves for fluid with a viscosity of water but to be substantially affected by the viscosity of the gastric content.
Anisotropic Effects on Constitutive Model Parameters of Aluminum Alloys
2012-01-01
constants are required input to computer codes (LS-DYNA, DYNA3D or SPH ) to accurately simulate fragment impact on structural components made of high...different temperatures. These model constants are required input to computer codes (LS-DYNA, DYNA3D or SPH ) to accurately simulate fragment impact on...ADDRESS(ES) Naval Surface Warfare Center,4104Evans Way Suite 102,Indian Head,MD,20640 8. PERFORMING ORGANIZATION REPORT NUMBER 9. SPONSORING/MONITORING
Case studies on optimization problems in MATLAB and COMSOL multiphysics by means of the livelink
NASA Astrophysics Data System (ADS)
Ozana, Stepan; Pies, Martin; Docekal, Tomas
2016-06-01
LiveLink for COMSOL is a tool that integrates COMSOL Multiphysics with MATLAB to extend one's modeling with scripting programming in the MATLAB environment. It allows user to utilize the full power of MATLAB and its toolboxes in preprocessing, model manipulation, and post processing. At first, the head script launches COMSOL with MATLAB and defines initial value of all parameters, refers to the objective function J described in the objective function and creates and runs the defined optimization task. Once the task is launches, the COMSOL model is being called in the iteration loop (from MATLAB environment by use of API interface), changing defined optimization parameters so that the objective function is minimized, using fmincon function to find a local or global minimum of constrained linear or nonlinear multivariable function. Once the minimum is found, it returns exit flag, terminates optimization and returns the optimized values of the parameters. The cooperation with MATLAB via LiveLink enhances a powerful computational environment with complex multiphysics simulations. The paper will introduce using of the LiveLink for COMSOL for chosen case studies in the field of technical cybernetics and bioengineering.
2014-04-01
Barrier methods for critical exponent problems in geometric analysis and mathematical physics, J. Erway and M. Holst, Submitted for publication ...TR-14-33 A Posteriori Error Analysis and Uncertainty Quantification for Adaptive Multiscale Operator Decomposition Methods for Multiphysics...Problems Approved for public release, distribution is unlimited. April 2014 HDTRA1-09-1-0036 Donald Estep and Michael
Exploring a Multiphysics Resolution Approach for Additive Manufacturing
NASA Astrophysics Data System (ADS)
Estupinan Donoso, Alvaro Antonio; Peters, Bernhard
2018-06-01
Metal additive manufacturing (AM) is a fast-evolving technology aiming to efficiently produce complex parts while saving resources. Worldwide, active research is being performed to solve the existing challenges of this growing technique. Constant computational advances have enabled multiscale and multiphysics numerical tools that complement the traditional physical experimentation. In this contribution, an advanced discrete-continuous concept is proposed to address the physical phenomena involved during laser powder bed fusion. The concept treats powder as discrete by the extended discrete element method, which predicts the thermodynamic state and phase change for each particle. The fluid surrounding is solved with multiphase computational fluid dynamics techniques to determine momentum, heat, gas and liquid transfer. Thus, results track the positions and thermochemical history of individual particles in conjunction with the prevailing fluid phases' temperature and composition. It is believed that this methodology can be employed to complement experimental research by analysis of the comprehensive results, which can be extracted from it to enable AM processes optimization for parts qualification.
Jali - Unstructured Mesh Infrastructure for Multi-Physics Applications
DOE Office of Scientific and Technical Information (OSTI.GOV)
Garimella, Rao V; Berndt, Markus; Coon, Ethan
2017-04-13
Jali is a parallel unstructured mesh infrastructure library designed for use by multi-physics simulations. It supports 2D and 3D arbitrary polyhedral meshes distributed over hundreds to thousands of nodes. Jali can read write Exodus II meshes along with fields and sets on the mesh and support for other formats is partially implemented or is (https://github.com/MeshToolkit/MSTK), an open source general purpose unstructured mesh infrastructure library from Los Alamos National Laboratory. While it has been made to work with other mesh frameworks such as MOAB and STKmesh in the past, support for maintaining the interface to these frameworks has been suspended formore » now. Jali supports distributed as well as on-node parallelism. Support of on-node parallelism is through direct use of the the mesh in multi-threaded constructs or through the use of "tiles" which are submeshes or sub-partitions of a partition destined for a compute node.« less
Multiphysics analysis of liquid metal annular linear induction pumps: A project overview
DOE Office of Scientific and Technical Information (OSTI.GOV)
Maidana, Carlos Omar; Nieminen, Juha E.
Liquid metal-cooled fission reactors are both moderated and cooled by a liquid metal solution. These reactors are typically very compact and they can be used in regular electric power production, for naval and space propulsion systems or in fission surface power systems for planetary exploration. The coupling between the electromagnetics and thermo-fluid mechanical phenomena observed in liquid metal thermo-magnetic systems for nuclear and space applications gives rise to complex engineering magnetohydrodynamics and numerical problems. It is known that electromagnetic pumps have a number of advantages over rotating mechanisms: absence of moving parts, low noise and vibration level, simplicity of flowmore » rate regulation, easy maintenance and so on. However, while developing annular linear induction pumps, we are faced with a significant problem of magnetohydrodynamic instability arising in the device. The complex flow behavior in this type of devices includes a time-varying Lorentz force and pressure pulsation due to the time-varying electromagnetic fields and the induced convective currents that originates from the liquid metal flow, leading to instability problems along the device geometry. The determinations of the geometry and electrical configuration of liquid metal thermo-magnetic devices give rise to a complex inverse magnetohydrodynamic field problem were techniques for global optimization should be used, magnetohydrodynamics instabilities understood –or quantified- and multiphysics models developed and analyzed. Lastly, we present a project overview as well as a few computational models developed to study liquid metal annular linear induction pumps using first principles and the a few results of our multi-physics analysis.« less
Multiphysics analysis of liquid metal annular linear induction pumps: A project overview
Maidana, Carlos Omar; Nieminen, Juha E.
2016-03-14
Liquid metal-cooled fission reactors are both moderated and cooled by a liquid metal solution. These reactors are typically very compact and they can be used in regular electric power production, for naval and space propulsion systems or in fission surface power systems for planetary exploration. The coupling between the electromagnetics and thermo-fluid mechanical phenomena observed in liquid metal thermo-magnetic systems for nuclear and space applications gives rise to complex engineering magnetohydrodynamics and numerical problems. It is known that electromagnetic pumps have a number of advantages over rotating mechanisms: absence of moving parts, low noise and vibration level, simplicity of flowmore » rate regulation, easy maintenance and so on. However, while developing annular linear induction pumps, we are faced with a significant problem of magnetohydrodynamic instability arising in the device. The complex flow behavior in this type of devices includes a time-varying Lorentz force and pressure pulsation due to the time-varying electromagnetic fields and the induced convective currents that originates from the liquid metal flow, leading to instability problems along the device geometry. The determinations of the geometry and electrical configuration of liquid metal thermo-magnetic devices give rise to a complex inverse magnetohydrodynamic field problem were techniques for global optimization should be used, magnetohydrodynamics instabilities understood –or quantified- and multiphysics models developed and analyzed. Lastly, we present a project overview as well as a few computational models developed to study liquid metal annular linear induction pumps using first principles and the a few results of our multi-physics analysis.« less
NASA Astrophysics Data System (ADS)
Khuwaileh, Bassam
High fidelity simulation of nuclear reactors entails large scale applications characterized with high dimensionality and tremendous complexity where various physics models are integrated in the form of coupled models (e.g. neutronic with thermal-hydraulic feedback). Each of the coupled modules represents a high fidelity formulation of the first principles governing the physics of interest. Therefore, new developments in high fidelity multi-physics simulation and the corresponding sensitivity/uncertainty quantification analysis are paramount to the development and competitiveness of reactors achieved through enhanced understanding of the design and safety margins. Accordingly, this dissertation introduces efficient and scalable algorithms for performing efficient Uncertainty Quantification (UQ), Data Assimilation (DA) and Target Accuracy Assessment (TAA) for large scale, multi-physics reactor design and safety problems. This dissertation builds upon previous efforts for adaptive core simulation and reduced order modeling algorithms and extends these efforts towards coupled multi-physics models with feedback. The core idea is to recast the reactor physics analysis in terms of reduced order models. This can be achieved via identifying the important/influential degrees of freedom (DoF) via the subspace analysis, such that the required analysis can be recast by considering the important DoF only. In this dissertation, efficient algorithms for lower dimensional subspace construction have been developed for single physics and multi-physics applications with feedback. Then the reduced subspace is used to solve realistic, large scale forward (UQ) and inverse problems (DA and TAA). Once the elite set of DoF is determined, the uncertainty/sensitivity/target accuracy assessment and data assimilation analysis can be performed accurately and efficiently for large scale, high dimensional multi-physics nuclear engineering applications. Hence, in this work a Karhunen-Loeve (KL
Ray-tracing 3D dust radiative transfer with DART-Ray: code upgrade and public release
NASA Astrophysics Data System (ADS)
Natale, Giovanni; Popescu, Cristina C.; Tuffs, Richard J.; Clarke, Adam J.; Debattista, Victor P.; Fischera, Jörg; Pasetto, Stefano; Rushton, Mark; Thirlwall, Jordan J.
2017-11-01
We present an extensively updated version of the purely ray-tracing 3D dust radiation transfer code DART-Ray. The new version includes five major upgrades: 1) a series of optimizations for the ray-angular density and the scattered radiation source function; 2) the implementation of several data and task parallelizations using hybrid MPI+OpenMP schemes; 3) the inclusion of dust self-heating; 4) the ability to produce surface brightness maps for observers within the models in HEALPix format; 5) the possibility to set the expected numerical accuracy already at the start of the calculation. We tested the updated code with benchmark models where the dust self-heating is not negligible. Furthermore, we performed a study of the extent of the source influence volumes, using galaxy models, which are critical in determining the efficiency of the DART-Ray algorithm. The new code is publicly available, documented for both users and developers, and accompanied by several programmes to create input grids for different model geometries and to import the results of N-body and SPH simulations. These programmes can be easily adapted to different input geometries, and for different dust models or stellar emission libraries.
NASA Astrophysics Data System (ADS)
Podgorney, Robert; Coleman, Justin; Wilkins, Amdrew; Huang, Hai; Veeraraghavan, Swetha; Xia, Yidong; Permann, Cody
2017-04-01
Numerical modeling has played an important role in understanding the behavior of coupled subsurface thermal-hydro-mechanical (THM) processes associated with a number of energy and environmental applications since as early as the 1970s. While the ability to rigorously describe all key tightly coupled controlling physics still remains a challenge, there have been significant advances in recent decades. These advances are related primarily to the exponential growth of computational power, the development of more accurate equations of state, improvements in the ability to represent heterogeneity and reservoir geometry, and more robust nonlinear solution schemes. The work described in this paper documents the development and linkage of several fully-coupled and fully-implicit modeling tools. These tools simulate: (1) the dynamics of fluid flow, heat transport, and quasi-static rock mechanics; (2) seismic wave propagation from the sources of energy release through heterogeneous material; and (3) the soil-structural damage resulting from ground acceleration. These tools are developed in Idaho National Laboratory's parallel Multiphysics Object Oriented Simulation Environment, and are integrated together using a global implicit approach. The governing equations are presented, the numerical approach for simultaneously solving and coupling the three coupling physics tools is discussed, and the data input and output methodology is outlined. An example is presented to demonstrate the capabilities of the coupled multiphysics approach. The example involves simulating a system conceptually similar to the geothermal development in Basel Switzerland, and the resultant induced seismicity, ground motion and structural damage is predicted.
Multiscale multiphysics and multidomain models—Flexibility and rigidity
Xia, Kelin; Opron, Kristopher; Wei, Guo-Wei
2013-01-01
The emerging complexity of large macromolecules has led to challenges in their full scale theoretical description and computer simulation. Multiscale multiphysics and multidomain models have been introduced to reduce the number of degrees of freedom while maintaining modeling accuracy and achieving computational efficiency. A total energy functional is constructed to put energies for polar and nonpolar solvation, chemical potential, fluid flow, molecular mechanics, and elastic dynamics on an equal footing. The variational principle is utilized to derive coupled governing equations for the above mentioned multiphysical descriptions. Among these governing equations is the Poisson-Boltzmann equation which describes continuum electrostatics with atomic charges. The present work introduces the theory of continuum elasticity with atomic rigidity (CEWAR). The essence of CEWAR is to formulate the shear modulus as a continuous function of atomic rigidity. As a result, the dynamics complexity of a macromolecular system is separated from its static complexity so that the more time-consuming dynamics is handled with continuum elasticity theory, while the less time-consuming static analysis is pursued with atomic approaches. We propose a simple method, flexibility-rigidity index (FRI), to analyze macromolecular flexibility and rigidity in atomic detail. The construction of FRI relies on the fundamental assumption that protein functions, such as flexibility, rigidity, and energy, are entirely determined by the structure of the protein and its environment, although the structure is in turn determined by all the interactions. As such, the FRI measures the topological connectivity of protein atoms or residues and characterizes the geometric compactness of the protein structure. As a consequence, the FRI does not resort to the interaction Hamiltonian and bypasses matrix diagonalization, which underpins most other flexibility analysis methods. FRI's computational complexity is of
A fully coupled 3D transport model in SPH for multi-species reaction-diffusion systems
DOE Office of Scientific and Technical Information (OSTI.GOV)
Adami, Stefan; Hu, X. Y.; Adams, N. A.
2011-08-23
Abstract—In this paper we present a fully generalized transport model for multiple species in complex two and threedimensional geometries. Based on previous work [1] we have extended our interfacial reaction-diffusion model to handle arbitrary numbers of species allowing for coupled reaction models. Each species is tracked independently and we consider different physics of a species with respect to the bulk phases in contact. We use our SPH model to simulate the reaction-diffusion problem on a pore-scale level of a solid oxide fuel cell (SOFC) with special emphasize on the effect of surface diffusion.
NASA Astrophysics Data System (ADS)
Fu, X.; Hu, L.; Lee, K. M.; Zou, J.; Ruan, X. D.; Yang, H. Y.
2010-10-01
This paper presents a method for dry calibration of an electromagnetic flowmeter (EMF). This method, which determines the voltage induced in the EMF as conductive liquid flows through a magnetic field, numerically solves a coupled set of multiphysical equations with measured boundary conditions for the magnetic, electric, and flow fields in the measuring pipe of the flowmeter. Specifically, this paper details the formulation of dry calibration and an efficient algorithm (that adaptively minimizes the number of measurements and requires only the normal component of the magnetic flux density as boundary conditions on the pipe surface to reconstruct the magnetic field involved) for computing the sensitivity of EMF. Along with an in-depth discussion on factors that could significantly affect the final precision of a dry calibrated EMF, the effects of flow disturbance on measuring errors have been experimentally studied by installing a baffle at the inflow port of the EMF. Results of the dry calibration on an actual EMF were compared against flow-rig calibration; excellent agreements (within 0.3%) between dry calibration and flow-rig tests verify the multiphysical computation of the fields and the robustness of the method. As requiring no actual flow, the dry calibration is particularly useful for calibrating large-diameter EMFs where conventional flow-rig methods are often costly and difficult to implement.
Geng, Tuoyu; Sutter, Alton; Harland, Michael D.; Law, Brittany A.; Ross, Jessica S.; Lewin, David; Palanisamy, Arun; Russo, Sarah B.; Chavin, Kenneth D.; Cowart, L. Ashley
2015-01-01
Steatohepatitis occurs in up to 20% of patients with fatty liver disease and leads to its primary disease outcomes, including fibrosis, cirrhosis, and increased risk of hepatocellular carcinoma. Mechanisms that mediate this inflammation are of major interest. We previously showed that overload of saturated fatty acids, such as that which occurs with metabolic syndrome, induced sphingosine kinase 1 (SphK1), an enzyme that generates sphingosine-1-phosphate (S1P). While data suggest beneficial roles for S1P in some contexts, we hypothesized that it may promote hepatic inflammation in the context of obesity. Consistent with this, we observed 2-fold elevation of this enzyme in livers from humans with nonalcoholic fatty liver disease and also in mice with high saturated fat feeding, which recapitulated the human disease. Mice exhibited activation of NFκB, elevated cytokine production, and immune cell infiltration. Importantly, SphK1-null mice were protected from these outcomes. Studies in cultured cells demonstrated saturated fatty acid induction of SphK1 message, protein, and activity, and also a requirement of the enzyme for NFκB signaling and increased mRNA encoding TNFα and MCP1. Moreover, saturated fat-induced NFκB signaling and elevation of TNFα and MCP1 mRNA in HepG2 cells was blocked by targeted knockdown of S1P receptor 1, supporting a role for this lipid signaling pathway in inflammation in nonalcoholic fatty liver disease. PMID:26482537
DOE Office of Scientific and Technical Information (OSTI.GOV)
Estep, Donald
2015-11-30
This project addressed the challenge of predictive computational analysis of strongly coupled, highly nonlinear multiphysics systems characterized by multiple physical phenomena that span a large range of length- and time-scales. Specifically, the project was focused on computational estimation of numerical error and sensitivity analysis of computational solutions with respect to variations in parameters and data. In addition, the project investigated the use of accurate computational estimates to guide efficient adaptive discretization. The project developed, analyzed and evaluated new variational adjoint-based techniques for integration, model, and data error estimation/control and sensitivity analysis, in evolutionary multiphysics multiscale simulations.
Crystal Structure of Faradaurate-279: Au279(SPh-tBu)84 Plasmonic Nanocrystal Molecules.
Sakthivel, Naga Arjun; Theivendran, Shevanuja; Ganeshraj, Vigneshraja; Oliver, Allen G; Dass, Amala
2017-11-01
We report the discovery of an unprecedentedly large, 2.2 nm diameter, thiolate protected gold nanocrystal characterized by single crystal X-ray crystallography (sc-XRD), Au 279 (SPh-tBu) 84 named Faradaurate-279 (F-279) in honor of Michael Faraday's (1857) pioneering work on nanoparticles. F-279 nanocrystal has a core-shell structure containing a truncated octahedral core with bulk face-centered cubic-like arrangement, yet a nanomolecule with a precise number of metal atoms and thiolate ligands. The Au 279 S 84 geometry was established from a low-temperature 120 K sc-XRD study at 0.90 Å resolution. The atom counts in core-shell structure of Au 279 follows the mathematical formula for magic number shells: Au@Au 12 @Au 42 @Au 92 @Au 54 , which is further protected by a final shell of Au 48 . Au 249 core is protected by three types of staple motifs, namely: 30 bridging, 18 monomeric, and 6 dimeric staple motifs. Despite the presence of such diverse staple motifs, Au 279 S 84 structure has a chiral pseudo-D 3 symmetry. The core-shell structure can be viewed as nested, concentric polyhedra, containing a total of five forms of Archimedean solids. A comparison between the Au 279 and Au 309 cuboctahedral superatom model in shell-wise growth is illustrated. F-279 can be synthesized and isolated in high purity in milligram quantities using size exclusion chromatography, as evidenced by mass spectrometry. Electrospray ionization-mass spectrometry independently verifies the X-ray diffraction study based heavy atoms formula, Au 279 S 84 , and establishes the molecular formula with the complete ligands, namely, Au 279 (SPh-tBu) 84 . It is also the smallest gold nanocrystal to exhibit metallic behavior, with a surface plasmon resonance band around 510 nm.
Surface tension models for a multi-material ALE code with AMR
DOE Office of Scientific and Technical Information (OSTI.GOV)
Liu, Wangyi; Koniges, Alice; Gott, Kevin
A number of surface tension models have been implemented in a 3D multi-physics multi-material code, ALE–AMR, which combines Arbitrary Lagrangian Eulerian (ALE) hydrodynamics with Adaptive Mesh Refinement (AMR). ALE–AMR is unique in its ability to model hot radiating plasmas, cold fragmenting solids, and most recently, the deformation of molten material. The surface tension models implemented include a diffuse interface approach with special numerical techniques to remove parasitic flow and a height function approach in conjunction with a volume-fraction interface reconstruction package. These surface tension models are benchmarked with a variety of test problems. In conclusion, based on the results, themore » height function approach using volume fractions was chosen to simulate droplet dynamics associated with extreme ultraviolet (EUV) lithography.« less
Surface tension models for a multi-material ALE code with AMR
Liu, Wangyi; Koniges, Alice; Gott, Kevin; ...
2017-06-01
A number of surface tension models have been implemented in a 3D multi-physics multi-material code, ALE–AMR, which combines Arbitrary Lagrangian Eulerian (ALE) hydrodynamics with Adaptive Mesh Refinement (AMR). ALE–AMR is unique in its ability to model hot radiating plasmas, cold fragmenting solids, and most recently, the deformation of molten material. The surface tension models implemented include a diffuse interface approach with special numerical techniques to remove parasitic flow and a height function approach in conjunction with a volume-fraction interface reconstruction package. These surface tension models are benchmarked with a variety of test problems. In conclusion, based on the results, themore » height function approach using volume fractions was chosen to simulate droplet dynamics associated with extreme ultraviolet (EUV) lithography.« less
Assessment of MARMOT. A Mesoscale Fuel Performance Code
DOE Office of Scientific and Technical Information (OSTI.GOV)
Tonks, M. R.; Schwen, D.; Zhang, Y.
2015-04-01
MARMOT is the mesoscale fuel performance code under development as part of the US DOE Nuclear Energy Advanced Modeling and Simulation Program. In this report, we provide a high level summary of MARMOT, its capabilities, and its current state of validation. The purpose of MARMOT is to predict the coevolution of microstructure and material properties of nuclear fuel and cladding. It accomplished this using the phase field method coupled to solid mechanics and heat conduction. MARMOT is based on the Multiphysics Object-Oriented Simulation Environment (MOOSE), and much of its basic capability in the areas of the phase field method, mechanics,more » and heat conduction come directly from MOOSE modules. However, additional capability specific to fuel and cladding is available in MARMOT. While some validation of MARMOT has been completed in the areas of fission gas behavior and grain growth, much more validation needs to be conducted. However, new mesoscale data needs to be obtained in order to complete this validation.« less
3D SPH numerical simulation of the wave generated by the Vajont rockslide
NASA Astrophysics Data System (ADS)
Vacondio, R.; Mignosa, P.; Pagani, S.
2013-09-01
A 3D numerical modeling of the wave generated by the Vajont slide, one of the most destructive ever occurred, is presented in this paper. A meshless Lagrangian Smoothed Particle Hydrodynamics (SPH) technique was adopted to simulate the highly fragmented violent flow generated by the falling slide in the artificial reservoir. The speed-up achievable via General Purpose Graphic Processing Units (GP-GPU) allowed to adopt the adequate resolution to describe the phenomenon. The comparison with the data available in literature showed that the results of the numerical simulation reproduce satisfactorily the maximum run-up, also the water surface elevation in the residual lake after the event. Moreover, the 3D velocity field of the flow during the event and the discharge hydrograph which overtopped the dam, were obtained.
SPH Simulation of Impact of a Surge on a Wall
NASA Astrophysics Data System (ADS)
Diwakar, Manoj Kumar; Mohapatra, Pranab Kumar; Tripathi, Shivam
2014-05-01
Structures located on the downstream of a dam are prone to impact of the surge due to dam break flow. Ramsden (1996) experimentally studied the run-up height on a vertical wall due to propagation of bore and surge on dry bed and measured their impact on the wall. Mohapatra et al. (2000) applied Navier Stokes equations to numerically study the impact of bore on vertical and inclined walls. They also obtained the evolution of surge on dry bed. In the present work, the impact of a surge wave due to dam break flow against the wall is modeled with a two-dimensional smoothed particle hydrodynamics (SPH) model. SPH is a mesh-free method that relies on the particle view of the field problem and approximates the continuity and momentum equations on a set of particles. The method solves the strong form of Navier-Stokes equations. The governing equations are solved numerically in the vertical plane. The propagation of the surge wave, its impact and the maximum run-up on the wall located at the boundary are analyzed. Surface profile, velocity field and pressure distributions are simulated. Non-dimensional run-up height obtained from the present numerical model is 0.86 and is in good agreement with the available experimental data of Ramsden (1996) which is in the range of 0.75-0.9. Also, the simulated profile of the surge tip was comparable to the empirical equations refereed in Ramsden (1996). The model is applied to the study the maximum force and the run-up height on inclined walls with different inclinations. The results indicate that the maximum force and the run-up height on the wall increase with the increment of wall inclination. Comparison of numerical results with analytical solutions derived from shallow water equations clearly shows the breakdown of shallow water assumption during the impact. In addition to these results, the numerical simulation yields the complete velocity and pressure ?elds which may be used to design structures located in the path of a dam
CRKSPH: A new meshfree hydrodynamics method with applications to astrophysics
NASA Astrophysics Data System (ADS)
Owen, John Michael; Raskin, Cody; Frontiere, Nicholas
2018-01-01
The study of astrophysical phenomena such as supernovae, accretion disks, galaxy formation, and large-scale structure formation requires computational modeling of, at a minimum, hydrodynamics and gravity. Developing numerical methods appropriate for these kinds of problems requires a number of properties: shock-capturing hydrodynamics benefits from rigorous conservation of invariants such as total energy, linear momentum, and mass; lack of obvious symmetries or a simplified spatial geometry to exploit necessitate 3D methods that ideally are Galilean invariant; the dynamic range of mass and spatial scales that need to be resolved can span many orders of magnitude, requiring methods that are highly adaptable in their space and time resolution. We have developed a new Lagrangian meshfree hydrodynamics method called Conservative Reproducing Kernel Smoothed Particle Hydrodynamics, or CRKSPH, in order to meet these goals. CRKSPH is a conservative generalization of the meshfree reproducing kernel method, combining the high-order accuracy of reproducing kernels with the explicit conservation of mass, linear momentum, and energy necessary to study shock-driven hydrodynamics in compressible fluids. CRKSPH's Lagrangian, particle-like nature makes it simple to combine with well-known N-body methods for modeling gravitation, similar to the older Smoothed Particle Hydrodynamics (SPH) method. Indeed, CRKSPH can be substituted for SPH in existing SPH codes due to these similarities. In comparison to SPH, CRKSPH is able to achieve substantially higher accuracy for a given number of points due to the explicitly consistent (and higher-order) interpolation theory of reproducing kernels, while maintaining the same conservation principles (and therefore applicability) as SPH. There are currently two coded implementations of CRKSPH available: one in the open-source research code Spheral, and the other in the high-performance cosmological code HACC. Using these codes we have applied
NASA Astrophysics Data System (ADS)
Ghazanfarian, Jafar; Saghatchi, Roozbeh; Gorji-Bandpy, Mofid
2016-08-01
This paper studies a two-dimensional incompressible viscous flow past a circular cylinder with in-line oscillation close to a free-surface. The sub-particle scale (SPS) turbulence model of a Lagrangian particle-based smoothed-particle hydrodynamics (SPH) method has been used to solve the full Navier-Stokes equations together with the continuity equation. The accuracy of numerical code has been verified using two cases consisting of an oscillating cylinder placed in the stationary fluid, and flow over a fixed cylinder close to a free-surface. Simulations are conducted for the Froude number of 0.3, the Reynolds numbers of 40 and 80, various gap ratios for fully-submerged and half-submerge cylinders. The dimensionless frequency and amplitude of oscillating have been chosen as 0.5, 0.8 and 10, 15, respectively. The selection of such a high oscillating frequency causes the flow regime to become turbulent. It is seen that the gap ratio defined as the ratio of cylinder distance from free-surface and its diameter, strongly affects the flow pattern and the magnitude of the drag and lift coefficients. The jet-like flow (the region above the cylinder and beneath the free-surface) creation is discussed in detail and showed that the strength of this jet-like flow is weakened when the gap ratio shrinks. It is seen that by decreasing the gap ratio, the lift and drag coefficients increase and decrease, respectively. It is found that the Reynolds number has an inverse effect on the drag and lift coefficients. Also, it is concluded that by increasing the amplitude of oscillation the drag coefficient increases.
NASA Astrophysics Data System (ADS)
Li, Yingkun; Chen, Xiong; Xu, Jinsheng; Zhou, Changsheng; Musa, Omer
2018-05-01
In this paper, numerical investigation of ignition transient in a dual pulse solid rocket motor has been conducted. An in-house code has been developed in order to solve multi-physics governing equations, including unsteady compressible flow, heat conduction and structural dynamic. The simplified numerical models for solid propellant ignition and combustion have been added. The conventional serial staggered algorithm is adopted to simulate the fluid structure interaction problems in a loosely-coupled manner. The accuracy of the coupling procedure is validated by the behavior of a cantilever panel subjected to a shock wave. Then, the detailed flow field development, flame propagation characteristics, pressure evolution in the combustion chamber, and the structural response of metal diaphragm are analyzed carefully. The burst-time and burst-pressure of the metal diaphragm are also obtained. The individual effects of the igniter's mass flow rate, metal diaphragm thickness and diameter on the ignition transient have been systemically compared. The numerical results show that the evolution of the flow field in the combustion chamber, the temperature distribution on the propellant surface and the pressure loading on the metal diaphragm surface present a strong three-dimensional behavior during the initial ignition stage. The rupture of metal diaphragm is not only related to the magnitude of pressure loading on the diaphragm surface, but also to the history of pressure loading. The metal diaphragm thickness and diameter have a significant effect on the burst-time and burst-pressure of metal diaphragm.
NASA Astrophysics Data System (ADS)
Marrone, S.; Colagrossi, A.; Chiron, L.; De Leffe, M.; Le Touzé, D.
2018-02-01
The violent water entry of flat plates is investigated using a Riemann-arbitrary Eulerian-Lagrangian (ALE) smoothed particle hydrodynamics (SPH) model. The test conditions are of interest for problems related to aircraft and helicopter emergency landing in water. Three main parameters are considered: the horizontal velocity, the approach angle (i.e., vertical to horizontal velocity ratio) and the pitch angle, α. Regarding the latter, small angles are considered in this study. As described in the theoretical work by Zhao and Faltinsen (1993), for small α a very thin, high-speed jet of water is formed, and the time-spatial gradients of the pressure field are extremely high. These test conditions are very challenging for numerical solvers. In the present study an enhanced SPH model is firstly tested on a purely vertical impact with deadrise angle α = 4°. An in-depth validation against analytical solutions and experimental results is carried out, highlighting the several critical aspects of the numerical modelling of this kind of flow, especially when pressure peaks are to be captured. A discussion on the main difficulties when comparing to model scale experiments is also provided. Then, the more realistic case of a plate with both horizontal and vertical velocity components is discussed and compared to ditching experiments recently carried out at CNR-INSEAN. In the latter case both 2-D and 3-D simulations are considered and the importance of 3-D effects on the pressure peak is discussed for α = 4° and α = 10°.
NASA Astrophysics Data System (ADS)
Nishiura, Daisuke; Furuichi, Mikito; Sakaguchi, Hide
2015-09-01
The computational performance of a smoothed particle hydrodynamics (SPH) simulation is investigated for three types of current shared-memory parallel computer devices: many integrated core (MIC) processors, graphics processing units (GPUs), and multi-core CPUs. We are especially interested in efficient shared-memory allocation methods for each chipset, because the efficient data access patterns differ between compute unified device architecture (CUDA) programming for GPUs and OpenMP programming for MIC processors and multi-core CPUs. We first introduce several parallel implementation techniques for the SPH code, and then examine these on our target computer architectures to determine the most effective algorithms for each processor unit. In addition, we evaluate the effective computing performance and power efficiency of the SPH simulation on each architecture, as these are critical metrics for overall performance in a multi-device environment. In our benchmark test, the GPU is found to produce the best arithmetic performance as a standalone device unit, and gives the most efficient power consumption. The multi-core CPU obtains the most effective computing performance. The computational speed of the MIC processor on Xeon Phi approached that of two Xeon CPUs. This indicates that using MICs is an attractive choice for existing SPH codes on multi-core CPUs parallelized by OpenMP, as it gains computational acceleration without the need for significant changes to the source code.
Crespo, Alejandro C.; Dominguez, Jose M.; Barreiro, Anxo; Gómez-Gesteira, Moncho; Rogers, Benedict D.
2011-01-01
Smoothed Particle Hydrodynamics (SPH) is a numerical method commonly used in Computational Fluid Dynamics (CFD) to simulate complex free-surface flows. Simulations with this mesh-free particle method far exceed the capacity of a single processor. In this paper, as part of a dual-functioning code for either central processing units (CPUs) or Graphics Processor Units (GPUs), a parallelisation using GPUs is presented. The GPU parallelisation technique uses the Compute Unified Device Architecture (CUDA) of nVidia devices. Simulations with more than one million particles on a single GPU card exhibit speedups of up to two orders of magnitude over using a single-core CPU. It is demonstrated that the code achieves different speedups with different CUDA-enabled GPUs. The numerical behaviour of the SPH code is validated with a standard benchmark test case of dam break flow impacting on an obstacle where good agreement with the experimental results is observed. Both the achieved speed-ups and the quantitative agreement with experiments suggest that CUDA-based GPU programming can be used in SPH methods with efficiency and reliability. PMID:21695185
Setoh, Yin Xiang; Amarilla, Alberto A; Peng, Nias Y; Slonchak, Andrii; Periasamy, Parthiban; Figueiredo, Luiz T M; Aquino, Victor H; Khromykh, Alexander A
2018-01-01
Rocio virus (ROCV) is an arbovirus belonging to the genus Flavivirus, family Flaviviridae. We present an updated sequence of ROCV strain SPH 34675 (GenBank: AY632542.4), the only available full genome sequence prior to this study. Using next-generation sequencing of the entire genome, we reveal substantial sequence variation from the prototype sequence, with 30 nucleotide differences amounting to 14 amino acid changes, as well as significant changes to predicted 3'UTR RNA structures. Our results present an updated and corrected sequence of a potential emerging human-virulent flavivirus uniquely indigenous to Brazil (GenBank: MF461639).
Assessment of a hybrid finite element and finite volume code for turbulent incompressible flows
Xia, Yidong; Wang, Chuanjin; Luo, Hong; ...
2015-12-15
Hydra-TH is a hybrid finite-element/finite-volume incompressible/low-Mach flow simulation code based on the Hydra multiphysics toolkit being developed and used for thermal-hydraulics applications. In the present work, a suite of verification and validation (V&V) test problems for Hydra-TH was defined to meet the design requirements of the Consortium for Advanced Simulation of Light Water Reactors (CASL). The intent for this test problem suite is to provide baseline comparison data that demonstrates the performance of the Hydra-TH solution methods. The simulation problems vary in complexity from laminar to turbulent flows. A set of RANS and LES turbulence models were used in themore » simulation of four classical test problems. Numerical results obtained by Hydra-TH agreed well with either the available analytical solution or experimental data, indicating the verified and validated implementation of these turbulence models in Hydra-TH. Where possible, we have attempted some form of solution verification to identify sensitivities in the solution methods, and to suggest best practices when using the Hydra-TH code.« less
Assessment of a hybrid finite element and finite volume code for turbulent incompressible flows
DOE Office of Scientific and Technical Information (OSTI.GOV)
Xia, Yidong; Wang, Chuanjin; Luo, Hong
Hydra-TH is a hybrid finite-element/finite-volume incompressible/low-Mach flow simulation code based on the Hydra multiphysics toolkit being developed and used for thermal-hydraulics applications. In the present work, a suite of verification and validation (V&V) test problems for Hydra-TH was defined to meet the design requirements of the Consortium for Advanced Simulation of Light Water Reactors (CASL). The intent for this test problem suite is to provide baseline comparison data that demonstrates the performance of the Hydra-TH solution methods. The simulation problems vary in complexity from laminar to turbulent flows. A set of RANS and LES turbulence models were used in themore » simulation of four classical test problems. Numerical results obtained by Hydra-TH agreed well with either the available analytical solution or experimental data, indicating the verified and validated implementation of these turbulence models in Hydra-TH. Where possible, we have attempted some form of solution verification to identify sensitivities in the solution methods, and to suggest best practices when using the Hydra-TH code.« less
Heterosubunit composition and crystal structures of a novel bacterial M16B metallopeptidase.
Maruyama, Yukie; Chuma, Asako; Mikami, Bunzo; Hashimoto, Wataru; Murata, Kousaku
2011-03-18
Three subfamilies of metallopeptidase family M16 enzymes--M16A, M16B, and M16C--are widely distributed among eukaryotes and prokaryotes. SPH2681, a periplasmic M16B protein found in Sphingomonas sp. strain A1, contains an HXXEH motif essential for Zn(2+) binding and catalytic activity. SPH2682 is another member of M16B, which lacks the metal-binding motif but conserves an active-site R/Y pair commonly found in the C-terminal half of M16 enzymes. Two genes coding for SPH2681 and SPH2682 assemble into a single operon in the bacterial genome. This study determined SPH2681 to be constitutively expressed in strain A1 cells grown on different carbon sources, suggesting a more general cellular function. SPH2681 and SPH2681/SPH2682 were overexpressed in Escherichia coli, purified, and characterized. SPH2681 was found to associate with SPH2682, forming a heterosubunit enzyme with peptidase activity, while SPH2681 alone exhibited no enzymatic activity. X-ray crystallography of the SPH2681/SPH2682 complex revealed two conformations (open and closed heterodimeric forms) within the same crystal. Compared with the closed form, the open form contains two subunits rotated away from each other by approximately 8°, increasing the distance between the zinc ion and active-site residues by up to 8 Å. In addition, many hydrogen bonds are formed or broken on change between the conformations of the heterodimers, suggesting that subunit dynamics is a prerequisite for catalysis. To our knowledge, this is the first report on both conformational forms of the same M16 peptidase, providing a unique insight into the general proteolytic mechanism of M16 proteases. Copyright © 2011 Elsevier Ltd. All rights reserved.
Progress on the Multiphysics Capabilities of the Parallel Electromagnetic ACE3P Simulation Suite
DOE Office of Scientific and Technical Information (OSTI.GOV)
Kononenko, Oleksiy
2015-03-26
ACE3P is a 3D parallel simulation suite that is being developed at SLAC National Accelerator Laboratory. Effectively utilizing supercomputer resources, ACE3P has become a key tool for the coupled electromagnetic, thermal and mechanical research and design of particle accelerators. Based on the existing finite-element infrastructure, a massively parallel eigensolver is developed for modal analysis of mechanical structures. It complements a set of the multiphysics tools in ACE3P and, in particular, can be used for the comprehensive study of microphonics in accelerating cavities ensuring the operational reliability of a particle accelerator.
Xenakis, A M; Lind, S J; Stansby, P K; Rogers, B D
2017-03-01
Tsunamis caused by landslides may result in significant destruction of the surroundings with both societal and industrial impact. The 1958 Lituya Bay landslide and tsunami is a recent and well-documented terrestrial landslide generating a tsunami with a run-up of 524 m. Although recent computational techniques have shown good performance in the estimation of the run-up height, they fail to capture all the physical processes, in particular, the landslide-entry profile and interaction with the water. Smoothed particle hydrodynamics (SPH) is a versatile numerical technique for describing free-surface and multi-phase flows, particularly those that exhibit highly nonlinear deformation in landslide-generated tsunamis. In the current work, the novel multi-phase incompressible SPH method with shifting is applied to the Lituya Bay tsunami and landslide and is the first methodology able to reproduce realistically both the run-up and landslide-entry as documented in a benchmark experiment. The method is the first paper to develop a realistic implementation of the physics that in addition to the non-Newtonian rheology of the landslide includes turbulence in the water phase and soil saturation. Sensitivity to the experimental initial conditions is also considered. This work demonstrates the ability of the proposed method in modelling challenging environmental multi-phase, non-Newtonian and turbulent flows.
NASA Astrophysics Data System (ADS)
Pierazzo, E.; Artemieva, N.; Asphaug, E.; Baldwin, E. C.; Cazamias, J.; Coker, R.; Collins, G. S.; Crawford, D. A.; Davison, T.; Elbeshausen, D.; Holsapple, K. A.; Housen, K. R.; Korycansky, D. G.; Wünnemann, K.
2008-12-01
Over the last few decades, rapid improvement of computer capabilities has allowed impact cratering to be modeled with increasing complexity and realism, and has paved the way for a new era of numerical modeling of the impact process, including full, three-dimensional (3D) simulations. When properly benchmarked and validated against observation, computer models offer a powerful tool for understanding the mechanics of impact crater formation. This work presents results from the first phase of a project to benchmark and validate shock codes. A variety of 2D and 3D codes were used in this study, from commercial products like AUTODYN, to codes developed within the scientific community like SOVA, SPH, ZEUS-MP, iSALE, and codes developed at U.S. National Laboratories like CTH, SAGE/RAGE, and ALE3D. Benchmark calculations of shock wave propagation in aluminum-on-aluminum impacts were performed to examine the agreement between codes for simple idealized problems. The benchmark simulations show that variability in code results is to be expected due to differences in the underlying solution algorithm of each code, artificial stability parameters, spatial and temporal resolution, and material models. Overall, the inter-code variability in peak shock pressure as a function of distance is around 10 to 20%. In general, if the impactor is resolved by at least 20 cells across its radius, the underestimation of peak shock pressure due to spatial resolution is less than 10%. In addition to the benchmark tests, three validation tests were performed to examine the ability of the codes to reproduce the time evolution of crater radius and depth observed in vertical laboratory impacts in water and two well-characterized aluminum alloys. Results from these calculations are in good agreement with experiments. There appears to be a general tendency of shock physics codes to underestimate the radius of the forming crater. Overall, the discrepancy between the model and experiment results is
Sheridan, P L; Schorpp, M; Voz, M L; Jones, K A
1995-03-03
We have isolated a human cDNA clone encoding HIP116, a protein that binds to the SPH repeats of the SV40 enhancer and to the TATA/inhibitor region of the human immunodeficiency virus (HIV)-1 promoter. The predicted HIP116 protein is related to the yeast SNF2/SWI2 transcription factor and to other members of this extended family and contains seven domains similar to those found in the vaccinia NTP1 ATPase. Interestingly, HIP116 also contains a C3HC4 zinc-binding motif (RING finger) interspersed between the ATPase motifs in an arrangement similar to that found in the yeast RAD5 and RAD16 proteins. The HIP116 amino terminus is unique among the members of this family, and houses a specific DNA-binding domain. Antiserum raised against HIP116 recognizes a 116-kDa nuclear protein in Western blots and specifically supershifts SV40 and HIV-1 protein-DNA complexes in gel shift experiments. The binding site for HIP116 on the SV40 enhancer directly overlaps the site for TEF-1, and like TEF-1, binding of HIP116 to the SV40 enhancer is destroyed by mutations that inhibit SPH enhancer activity in vivo. Purified fractions of HIP116 display strong ATPase activity that is preferentially stimulated by SPH DNA and can be inhibited specifically by antibodies to HIP116. These findings suggest that HIP116 might affect transcription, directly or indirectly, by acting as a DNA binding site-specific ATPase.
Multi-Physics Demonstration Problem with the SHARP Reactor Simulation Toolkit
DOE Office of Scientific and Technical Information (OSTI.GOV)
Merzari, E.; Shemon, E. R.; Yu, Y. Q.
This report describes to employ SHARP to perform a first-of-a-kind analysis of the core radial expansion phenomenon in an SFR. This effort required significant advances in the framework Multi-Physics Demonstration Problem with the SHARP Reactor Simulation Toolkit used to drive the coupled simulations, manipulate the mesh in response to the deformation of the geometry, and generate the necessary modified mesh files. Furthermore, the model geometry is fairly complex, and consistent mesh generation for the three physics modules required significant effort. Fully-integrated simulations of a 7-assembly mini-core test problem have been performed, and the results are presented here. Physics models ofmore » a full-core model of the Advanced Burner Test Reactor have also been developed for each of the three physics modules. Standalone results of each of the three physics modules for the ABTR are presented here, which provides a demonstration of the feasibility of the fully-integrated simulation.« less
Comparing Results of SPH/N-body Impact Simulations Using Both Solid and Rubble-pile Target Asteroids
NASA Astrophysics Data System (ADS)
Durda, Daniel D.; Bottke, W. F.; Enke, B. L.; Nesvorný, D.; Asphaug, E.; Richardson, D. C.
2006-09-01
We have been investigating the properties of satellites and the morphology of size-frequency distributions (SFDs) resulting from a suite of 160 SPH/N-body simulations of impacts into 100-km diameter parent asteroids (Durda et al. 2004, Icarus 170, 243-257; Durda et al. 2006, Icarus, in press). These simulations have produced many valuable insights into the outcomes of cratering and disruptive impacts but were limited to monolithic basalt targets. As a natural consequence of collisional evolution, however, many asteroids have undergone a series of battering impacts that likely have left their interiors substantially fractured, if not completely rubblized. In light of this, we have re-mapped the matrix of simulations using rubble-pile target objects. We constructed the rubble-pile targets by filling the interior of the 100-km diameter spherical shell (the target envelope) with randomly sized solid spheres in mutual contact. We then assigned full damage (which reduces tensile and shear stresses to zero) to SPH particles in the contacts between the components; the remaining volume is void space. The internal spherical components have a power-law distribution of sizes simulating fragments of a pre-shattered parent object. First-look analysis of the rubble-pile results indicate some general similarities to the simulations with the monolithic targets (e.g., similar trends in the number of small, gravitationally bound satellite systems as a function of impact conditions) and some significant differences (e.g., size of largest remnants and smaller debris affecting size frequency distributions of resulting families). We will report details of a more thorough analysis and the implications for collisional models of the main asteroid belt. This work is supported by the National Science Foundation, grant number AST0407045.
Consistent multiphysics simulation of a central tower CSP plant as applied to ISTORE
NASA Astrophysics Data System (ADS)
Votyakov, Evgeny V.; Papanicolas, Costas N.
2017-06-01
We present a unified consistent multiphysics approach to model a central tower CSP plant. The framework for the model includes Monte Carlo ray tracing (RT) and computational fluid dynamics (CFD) components utilizing the OpenFOAM C++ software library. The RT part works effectively with complex surfaces of engineering design given in CAD formats. The CFD simulation, which is based on 3D Navier-Stokes equations, takes into account all possible heat transfer mechanisms: radiation, conduction, and convection. Utilizing this package, the solar field of the experimental Platform for Research, Observation, and TEchnological Applications in Solar Energy (PROTEAS) and the Integrated STOrage and Receiver (ISTORE), developed at the Cyprus Institute, are being examined.
Solid Rocket Motor Combustion Instability Modeling in COMSOL Multiphysics
NASA Technical Reports Server (NTRS)
Fischbach, S. R.
2015-01-01
Combustion instability modeling of Solid Rocket Motors (SRM) remains a topic of active research. Many rockets display violent fluctuations in pressure, velocity, and temperature originating from the complex interactions between the combustion process, acoustics, and steady-state gas dynamics. Recent advances in defining the energy transport of disturbances within steady flow-fields have been applied by combustion stability modelers to improve the analysis framework. Employing this more accurate global energy balance requires a higher fidelity model of the SRM flow-field and acoustic mode shapes. The current industry standard analysis tool utilizes a one dimensional analysis of the time dependent fluid dynamics along with a quasi-three dimensional propellant grain regression model to determine the SRM ballistics. The code then couples with another application that calculates the eigenvalues of the one dimensional homogenous wave equation. The mean flow parameters and acoustic normal modes are coupled to evaluate the stability theory developed and popularized by Culick. The assumption of a linear, non-dissipative wave in a quiescent fluid remains valid while acoustic amplitudes are small and local gas velocities stay below Mach 0.2. The current study employs the COMSOL Multiphysics finite element framework to model the steady flow-field parameters and acoustic normal modes of a generic SRM. This work builds upon previous efforts to verify the use of the acoustic velocity potential equation (AVPE) laid out by Campos. The acoustic velocity potential (psi) describing the acoustic wave motion in the presence of an inhomogeneous steady high-speed flow is defined by, del squared psi - (lambda/c) squared psi - M x [M x del((del)(psi))] - 2((lambda)(M)/c + M x del(M) x (del)(psi) - 2(lambda)(psi)[M x del(1/c)] = 0. with M as the Mach vector, c as the speed of sound, and ? as the complex eigenvalue. The study requires one way coupling of the CFD High Mach Number Flow (HMNF
NASA Astrophysics Data System (ADS)
Spiegelman, M.; Wilson, C. R.
2011-12-01
A quantitative theory of magma production and transport is essential for understanding the dynamics of magmatic plate boundaries, intra-plate volcanism and the geochemical evolution of the planet. It also provides one of the most challenging computational problems in solid Earth science, as it requires consistent coupling of fluid and solid mechanics together with the thermodynamics of melting and reactive flows. Considerable work on these problems over the past two decades shows that small changes in assumptions of coupling (e.g. the relationship between melt fraction and solid rheology), can have profound changes on the behavior of these systems which in turn affects critical computational choices such as discretizations, solvers and preconditioners. To make progress in exploring and understanding this physically rich system requires a computational framework that allows more flexible, high-level description of multi-physics problems as well as increased flexibility in composing efficient algorithms for solution of the full non-linear coupled system. Fortunately, recent advances in available computational libraries and algorithms provide a platform for implementing such a framework. We present results from a new model building system that leverages functionality from both the FEniCS project (www.fenicsproject.org) and PETSc libraries (www.mcs.anl.gov/petsc) along with a model independent options system and gui, Spud (amcg.ese.ic.ac.uk/Spud). Key features from FEniCS include fully unstructured FEM with a wide range of elements; a high-level language (ufl) and code generation compiler (FFC) for describing the weak forms of residuals and automatic differentiation for calculation of exact and approximate jacobians. The overall strategy is to monitor/calculate residuals and jacobians for the entire non-linear system of equations within a global non-linear solve based on PETSc's SNES routines. PETSc already provides a wide range of solvers and preconditioners, from
NASA Astrophysics Data System (ADS)
Wilson, Cian R.; Spiegelman, Marc; van Keken, Peter E.
2017-02-01
We introduce and describe a new software infrastructure TerraFERMA, the Transparent Finite Element Rapid Model Assembler, for the rapid and reproducible description and solution of coupled multiphysics problems. The design of TerraFERMA is driven by two computational needs in Earth sciences. The first is the need for increased flexibility in both problem description and solution strategies for coupled problems where small changes in model assumptions can lead to dramatic changes in physical behavior. The second is the need for software and models that are more transparent so that results can be verified, reproduced, and modified in a manner such that the best ideas in computation and Earth science can be more easily shared and reused. TerraFERMA leverages three advanced open-source libraries for scientific computation that provide high-level problem description (FEniCS), composable solvers for coupled multiphysics problems (PETSc), and an options handling system (SPuD) that allows the hierarchical management of all model options. TerraFERMA integrates these libraries into an interface that organizes the scientific and computational choices required in a model into a single options file from which a custom compiled application is generated and run. Because all models share the same infrastructure, models become more reusable and reproducible, while still permitting the individual researcher considerable latitude in model construction. TerraFERMA solves partial differential equations using the finite element method. It is particularly well suited for nonlinear problems with complex coupling between components. TerraFERMA is open-source and available at http://terraferma.github.io, which includes links to documentation and example input files.
Modelling in conventional electroporation for model cell with organelles using COMSOL Multiphysics
NASA Astrophysics Data System (ADS)
Sulaeman, M. Y.; Widita, R.
2016-03-01
Conventional electroporation is a formation of pores in the membrane cell due to the external electric field applied to the cell. The purpose of creating pores in the cell using conventional electroporation are to increase the effectiveness of chemotherapy (electrochemotherapy) and to kill cancer tissue using irreversible electroporation. Modeling of electroporation phenomenon on a model cell had been done by using software COMSOL Multiphysics 4.3b with the applied external electric field with intensity at 1.1 kV/cm to find transmembrane voltage and pore density. It can be concluded from the results of potential distribution and transmembrane voltage, it show that pores formation only occurs in the membrane cells and it could not penetrate into inside the model cell so there is not pores formation in its organells.
iTOUGH2: A multiphysics simulation-optimization framework for analyzing subsurface systems
NASA Astrophysics Data System (ADS)
Finsterle, S.; Commer, M.; Edmiston, J. K.; Jung, Y.; Kowalsky, M. B.; Pau, G. S. H.; Wainwright, H. M.; Zhang, Y.
2017-11-01
iTOUGH2 is a simulation-optimization framework for the TOUGH suite of nonisothermal multiphase flow models and related simulators of geophysical, geochemical, and geomechanical processes. After appropriate parameterization of subsurface structures and their properties, iTOUGH2 runs simulations for multiple parameter sets and analyzes the resulting output for parameter estimation through automatic model calibration, local and global sensitivity analyses, data-worth analyses, and uncertainty propagation analyses. Development of iTOUGH2 is driven by scientific challenges and user needs, with new capabilities continually added to both the forward simulator and the optimization framework. This review article provides a summary description of methods and features implemented in iTOUGH2, and discusses the usefulness and limitations of an integrated simulation-optimization workflow in support of the characterization and analysis of complex multiphysics subsurface systems.
Astashkin, Andrei V; Neese, Frank; Raitsimring, Arnold M; Cooney, J Jon A; Bultman, Eric; Enemark, John H
2005-11-30
Ka band ESEEM spectroscopy was used to determine the hyperfine (hfi) and nuclear quadrupole (nqi) interaction parameters for the oxo-17O ligand in [Mo 17O(SPh)4]-, a spectroscopic model of the oxo-Mo(V) centers of enzymes. The isotropic hfi constant of 6.5 MHz found for the oxo-17O is much smaller than the values of approximately 20-40 MHz typical for the 17O nucleus of an equatorial OH(2) ligand in molybdenum enzymes. The 17O nqi parameter (e2qQ/h = 1.45 MHz, eta approximately = 0) is the first to be obtained for an oxo group in a metal complex. The parameters of the oxo-17O ligand, as well as other magnetic resonance parameters of [Mo 17O(SPh)4]- predicted by quasi-relativistic DFT calculations, were in good agreement with those obtained in experiment. From the electronic structure of the complex revealed by DFT, it follows that the SOMO is almost entirely molybdenum d(xy) and sulfur p, while the spin density on the oxo-17O is negative, determined by spin polarization mechanisms. The results of this work will enable direct experimental identification of the oxo ligand in a variety of chemical and biological systems.
Gas stripping and mixing in galaxy clusters: a numerical comparison study
NASA Astrophysics Data System (ADS)
Heß, Steffen; Springel, Volker
2012-11-01
The ambient hot intrahalo gas in clusters of galaxies is constantly fed and stirred by infalling galaxies, a process that can be studied in detail with cosmological hydrodynamical simulations. However, different numerical methods yield discrepant predictions for crucial hydrodynamical processes, leading for example to different entropy profiles in clusters of galaxies. In particular, the widely used Lagrangian smoothed particle hydrodynamics (SPH) scheme is suspected to strongly damp fluid instabilities and turbulence, which are both crucial to establish the thermodynamic structure of clusters. In this study, we test to which extent our recently developed Voronoi particle hydrodynamics (VPH) scheme yields different results for the stripping of gas out of infalling galaxies and for the bulk gas properties of cluster. We consider both the evolution of isolated galaxy models that are exposed to a stream of intracluster medium or are dropped into cluster models, as well as non-radiative cosmological simulations of cluster formation. We also compare our particle-based method with results obtained with a fundamentally different discretization approach as implemented in the moving-mesh code AREPO. We find that VPH leads to noticeably faster stripping of gas out of galaxies than SPH, in better agreement with the mesh-code than with SPH. We show that despite the fact that VPH in its present form is not as accurate as the moving mesh code in our investigated cases, its improved accuracy of gradient estimates makes VPH an attractive alternative to SPH.
Suzuki, Yuma; Shimizu, Tetsuhide; Yang, Ming
2017-01-01
The quantitative evaluation of the biomolecules transport with multi-physics in nano/micro scale is demanded in order to optimize the design of microfluidics device for the biomolecules detection with high detection sensitivity and rapid diagnosis. This paper aimed to investigate the effectivity of the computational simulation using the numerical model of the biomolecules transport with multi-physics near a microchannel surface on the development of biomolecules-detection devices. The biomolecules transport with fluid drag force, electric double layer (EDL) force, and van der Waals force was modeled by Newtonian Equation of motion. The model validity was verified in the influence of ion strength and flow velocity on biomolecules distribution near the surface compared with experimental results of previous studies. The influence of acting forces on its distribution near the surface was investigated by the simulation. The trend of its distribution to ion strength and flow velocity was agreement with the experimental result by the combination of all acting forces. Furthermore, EDL force dominantly influenced its distribution near its surface compared with fluid drag force except for the case of high velocity and low ion strength. The knowledges from the simulation might be useful for the design of biomolecules-detection devices and the simulation can be expected to be applied on its development as the design tool for high detection sensitivity and rapid diagnosis in the future.
NASA Astrophysics Data System (ADS)
Poulet, Thomas; Paesold, Martin; Veveakis, Manolis
2017-03-01
Faults play a major role in many economically and environmentally important geological systems, ranging from impermeable seals in petroleum reservoirs to fluid pathways in ore-forming hydrothermal systems. Their behavior is therefore widely studied and fault mechanics is particularly focused on the mechanisms explaining their transient evolution. Single faults can change in time from seals to open channels as they become seismically active and various models have recently been presented to explain the driving forces responsible for such transitions. A model of particular interest is the multi-physics oscillator of Alevizos et al. (J Geophys Res Solid Earth 119(6), 4558-4582, 2014) which extends the traditional rate and state friction approach to rate and temperature-dependent ductile rocks, and has been successfully applied to explain spatial features of exposed thrusts as well as temporal evolutions of current subduction zones. In this contribution we implement that model in REDBACK, a parallel open-source multi-physics simulator developed to solve such geological instabilities in three dimensions. The resolution of the underlying system of equations in a tightly coupled manner allows REDBACK to capture appropriately the various theoretical regimes of the system, including the periodic and non-periodic instabilities. REDBACK can then be used to simulate the drastic permeability evolution in time of such systems, where nominally impermeable faults can sporadically become fluid pathways, with permeability increases of several orders of magnitude.
Multiphysics Model of Palladium Hydride Isotope Exchange Accounting for Higher Dimensionality
DOE Office of Scientific and Technical Information (OSTI.GOV)
Gharagozloo, Patricia E.; Eliassi, Mehdi; Bon, Bradley Luis
2015-03-01
This report summarizes computational model developm ent and simulations results for a series of isotope exchange dynamics experiments i ncluding long and thin isothermal beds similar to the Foltz and Melius beds and a lar ger non-isothermal experiment on the NENG7 test bed. The multiphysics 2D axi-symmetr ic model simulates the temperature and pressure dependent exchange reactio n kinetics, pressure and isotope dependent stoichiometry, heat generation from the r eaction, reacting gas flow through porous media, and non-uniformities in the bed perme ability. The new model is now able to replicate the curved reaction front and asy mmetry of themore » exit gas mass fractions over time. The improved understanding of the exchange process and its dependence on the non-uniform bed properties and te mperatures in these larger systems is critical to the future design of such sy stems.« less
Lind, S. J.; Stansby, P. K.; Rogers, B. D.
2017-01-01
Tsunamis caused by landslides may result in significant destruction of the surroundings with both societal and industrial impact. The 1958 Lituya Bay landslide and tsunami is a recent and well-documented terrestrial landslide generating a tsunami with a run-up of 524 m. Although recent computational techniques have shown good performance in the estimation of the run-up height, they fail to capture all the physical processes, in particular, the landslide-entry profile and interaction with the water. Smoothed particle hydrodynamics (SPH) is a versatile numerical technique for describing free-surface and multi-phase flows, particularly those that exhibit highly nonlinear deformation in landslide-generated tsunamis. In the current work, the novel multi-phase incompressible SPH method with shifting is applied to the Lituya Bay tsunami and landslide and is the first methodology able to reproduce realistically both the run-up and landslide-entry as documented in a benchmark experiment. The method is the first paper to develop a realistic implementation of the physics that in addition to the non-Newtonian rheology of the landslide includes turbulence in the water phase and soil saturation. Sensitivity to the experimental initial conditions is also considered. This work demonstrates the ability of the proposed method in modelling challenging environmental multi-phase, non-Newtonian and turbulent flows. PMID:28413334
DOE Office of Scientific and Technical Information (OSTI.GOV)
Yu, Y. Q.; Shemon, E. R.; Thomas, J. W.
SHARP is an advanced modeling and simulation toolkit for the analysis of nuclear reactors. It is comprised of several components including physical modeling tools, tools to integrate the physics codes for multi-physics analyses, and a set of tools to couple the codes within the MOAB framework. Physics modules currently include the neutronics code PROTEUS, the thermal-hydraulics code Nek5000, and the structural mechanics code Diablo. This manual focuses on performing multi-physics calculations with the SHARP ToolKit. Manuals for the three individual physics modules are available with the SHARP distribution to help the user to either carry out the primary multi-physics calculationmore » with basic knowledge or perform further advanced development with in-depth knowledge of these codes. This manual provides step-by-step instructions on employing SHARP, including how to download and install the code, how to build the drivers for a test case, how to perform a calculation and how to visualize the results. Since SHARP has some specific library and environment dependencies, it is highly recommended that the user read this manual prior to installing SHARP. Verification tests cases are included to check proper installation of each module. It is suggested that the new user should first follow the step-by-step instructions provided for a test problem in this manual to understand the basic procedure of using SHARP before using SHARP for his/her own analysis. Both reference output and scripts are provided along with the test cases in order to verify correct installation and execution of the SHARP package. At the end of this manual, detailed instructions are provided on how to create a new test case so that user can perform novel multi-physics calculations with SHARP. Frequently asked questions are listed at the end of this manual to help the user to troubleshoot issues.« less
A multi-physics model for ultrasonically activated soft tissue.
Suvranu De, Rahul
2017-02-01
A multi-physics model has been developed to investigate the effects of cellular level mechanisms on the thermomechanical response of ultrasonically activated soft tissue. Cellular level cavitation effects have been incorporated in the tissue level continuum model to accurately determine the thermodynamic states such as temperature and pressure. A viscoelastic material model is assumed for the macromechanical response of the tissue. The cavitation model based equation-of-state provides the additional pressure arising from evaporation of intracellular and cellular water by absorbing heat due to structural and viscoelastic heating in the tissue, and temperature to the continuum level thermomechanical model. The thermomechanical response of soft tissue is studied for the operational range of frequencies of oscillations and applied loads for typical ultrasonically activated surgical instruments. The model is shown to capture characteristics of ultrasonically activated soft tissue deformation and temperature evolution. At the cellular level, evaporation of water below the boiling temperature under ambient conditions is indicative of protein denaturation around the temperature threshold for coagulation of tissues. Further, with increasing operating frequency (or loading), the temperature rises faster leading to rapid evaporation of tissue cavity water, which may lead to accelerated protein denaturation and coagulation.
NASA Astrophysics Data System (ADS)
Jokisaari, Andrea M.
Hydride precipitation in zirconium is a significant factor limiting the lifetime of nuclear fuel cladding, because hydride microstructures play a key role in the degradation of fuel cladding. However, the behavior of hydrogen in zirconium has typically been modeled using mean field approaches, which do not consider microstructural evolution. This thesis describes a quantitative microstructural evolution model for the alpha-zirconium/delta-hydride system and the associated numerical methods and algorithms that were developed. The multiphysics, phase field-based model incorporates CALPHAD free energy descriptions, linear elastic solid mechanics, and classical nucleation theory. A flexible simulation software implementing the model, Hyrax, is built on the Multiphysics Object Oriented Simulation Environment (MOOSE) finite element framework. Hyrax is open-source and freely available; moreover, the numerical methods and algorithms that have been developed are generalizable to other systems. The algorithms are described in detail, and verification studies for each are discussed. In addition, analyses of the sensitivity of the simulation results to the choice of numerical parameters are presented. For example, threshold values for the CALPHAD free energy algorithm and the use of mesh and time adaptivity when employing the nucleation algorithm are studied. Furthermore, preliminary insights into the nucleation behavior of delta-hydrides are described. These include a) the sensitivities of the nucleation rate to temperature, interfacial energy, composition and elastic energy, b) the spatial variation of the nucleation rate around a single precipitate, and c) the effect of interfacial energy and nucleation rate on the precipitate microstructure. Finally, several avenues for future work are discussed. Topics encompass the terminal solid solubility hysteresis of hydrogen in zirconium and the effects of the alpha/delta interfacial energy, as well as thermodiffusion, plasticity
DOE Office of Scientific and Technical Information (OSTI.GOV)
Aly, A.; Avramova, Maria; Ivanov, Kostadin
To correctly describe and predict this hydrogen distribution there is a need for multi-physics coupling to provide accurate three-dimensional azimuthal, radial, and axial temperature distributions in the cladding. Coupled high-fidelity reactor-physics codes with a sub-channel code as well as with a computational fluid dynamics (CFD) tool have been used to calculate detailed temperature distributions. These high-fidelity coupled neutronics/thermal-hydraulics code systems are coupled further with the fuel-performance BISON code with a kernel (module) for hydrogen. Both hydrogen migration and precipitation/dissolution are included in the model. Results from this multi-physics analysis is validated utilizing calculations of hydrogen distribution using models informed bymore » data from hydrogen experiments and PIE data.« less
Mechanical behavior simulation of MEMS-based cantilever beam using COMSOL multiphysics
DOE Office of Scientific and Technical Information (OSTI.GOV)
Acheli, A., E-mail: aacheli@cdta.dz; Serhane, R.
This paper presents the studies of mechanical behavior of MEMS cantilever beam made of poly-silicon material, using the coupling of three application modes (plane strain, electrostatics and the moving mesh) of COMSOL Multi-physics software. The cantilevers playing a key role in Micro Electro-Mechanical Systems (MEMS) devices (switches, resonators, etc) working under potential shock. This is why they require actuation under predetermined conditions, such as electrostatic force or inertial force. In this paper, we present mechanical behavior of a cantilever actuated by an electrostatic force. In addition to the simplification of calculations, the weight of the cantilever was not taken intomore » account. Different parameters like beam displacement, electrostatics force and stress over the beam have been calculated by finite element method after having defining the geometry, the material of the cantilever model (fixed at one of ends but is free to move otherwise) and his operational space.« less
A multiphysical ensemble system of numerical snow modelling
NASA Astrophysics Data System (ADS)
Lafaysse, Matthieu; Cluzet, Bertrand; Dumont, Marie; Lejeune, Yves; Vionnet, Vincent; Morin, Samuel
2017-05-01
Physically based multilayer snowpack models suffer from various modelling errors. To represent these errors, we built the new multiphysical ensemble system ESCROC (Ensemble System Crocus) by implementing new representations of different physical processes in the deterministic coupled multilayer ground/snowpack model SURFEX/ISBA/Crocus. This ensemble was driven and evaluated at Col de Porte (1325 m a.s.l., French alps) over 18 years with a high-quality meteorological and snow data set. A total number of 7776 simulations were evaluated separately, accounting for the uncertainties of evaluation data. The ability of the ensemble to capture the uncertainty associated to modelling errors is assessed for snow depth, snow water equivalent, bulk density, albedo and surface temperature. Different sub-ensembles of the ESCROC system were studied with probabilistic tools to compare their performance. Results show that optimal members of the ESCROC system are able to explain more than half of the total simulation errors. Integrating members with biases exceeding the range corresponding to observational uncertainty is necessary to obtain an optimal dispersion, but this issue can also be a consequence of the fact that meteorological forcing uncertainties were not accounted for. The ESCROC system promises the integration of numerical snow-modelling errors in ensemble forecasting and ensemble assimilation systems in support of avalanche hazard forecasting and other snowpack-modelling applications.
NASA Technical Reports Server (NTRS)
Madura, Thomas I.; Gull, Theodore R.; Owocki, Stanley P.; Okazaki, Atsuo T.; Russell, Christopher M. P.
2011-01-01
The extremely massive (> 90 Stellar Mass) and luminous (= 5 x 10(exp 6) Stellar Luminosity) star Eta Carinae, with its spectacular bipolar "Homunculus" nebula, comprises one of the most remarkable and intensely observed stellar systems in the Galaxy. However, many of its underlying physical parameters remain unknown. Multiwavelength variations observed to occur every 5.54 years are interpreted as being due to the collision of a massive wind from the primary star with the fast, less dense wind of a hot companion star in a highly elliptical (e approx. 0.9) orbit. Using three-dimensional (3-D) Smoothed Particle Hydrodynamics (SPH) simulations of the binary wind-wind collision, together with radiative transfer codes, we compute synthetic spectral images of [Fe III] emission line structures and compare them to existing Hubble Space Telescope/Space Telescope Imaging Spectrograph (HST/STIS) observations. We are thus able, for the first time, to tightly constrain the absolute orientation of the binary orbit on the sky. An orbit with an inclination of approx. 40deg, an argument of periapsis omega approx. 255deg, and a projected orbital axis with a position angle of approx. 312deg east of north provides the best fit to the observations, implying that the orbital axis is closely aligned in 3-D space with the Homunculus symmetry axis, and that the companion star orbits clockwise on the sky relative to the primary.
Dass, Amala; Theivendran, Shevanuja; Nimmala, Praneeth Reddy; Kumara, Chanaka; Jupally, Vijay Reddy; Fortunelli, Alessandro; Sementa, Luca; Barcaro, Giovanni; Zuo, Xiaobing; Noll, Bruce C
2015-04-15
Crystal structure determination has revolutionized modern science in biology, chemistry, and physics. However, the difficulty in obtaining periodic crystal lattices which are needed for X-ray crystal analysis has hindered the determination of atomic structure in nanomaterials, known as the "nanostructure problem". Here, by using rigid and bulky ligands, we have overcome this limitation and successfully solved the X-ray crystallographic structure of the largest reported thiolated gold nanomolecule, Au133S52. The total composition, Au133(SPh-tBu)52, was verified using high resolution electrospray ionization mass spectrometry (ESI-MS). The experimental and simulated optical spectra show an emergent surface plasmon resonance that is more pronounced than in the slightly larger Au144(SCH2CH2Ph)60. Theoretical analysis indicates that the presence of rigid and bulky ligands is the key to the successful crystal formation.
The moving-least-squares-particle hydrodynamics method (MLSPH)
DOE Office of Scientific and Technical Information (OSTI.GOV)
Dilts, G.
1997-12-31
An enhancement of the smooth-particle hydrodynamics (SPH) method has been developed using the moving-least-squares (MLS) interpolants of Lancaster and Salkauskas which simultaneously relieves the method of several well-known undesirable behaviors, including spurious boundary effects, inaccurate strain and rotation rates, pressure spikes at impact boundaries, and the infamous tension instability. The classical SPH method is derived in a novel manner by means of a Galerkin approximation applied to the Lagrangian equations of motion for continua using as basis functions the SPH kernel function multiplied by the particle volume. This derivation is then modified by simply substituting the MLS interpolants for themore » SPH Galerkin basis, taking care to redefine the particle volume and mass appropriately. The familiar SPH kernel approximation is now equivalent to a colocation-Galerkin method. Both classical conservative and recent non-conservative formulations of SPH can be derived and emulated. The non-conservative forms can be made conservative by adding terms that are zero within the approximation at the expense of boundary-value considerations. The familiar Monaghan viscosity is used. Test calculations of uniformly expanding fluids, the Swegle example, spinning solid disks, impacting bars, and spherically symmetric flow illustrate the superiority of the technique over SPH. In all cases it is seen that the marvelous ability of the MLS interpolants to add up correctly everywhere civilizes the noisy, unpredictable nature of SPH. Being a relatively minor perturbation of the SPH method, it is easily retrofitted into existing SPH codes. On the down side, computational expense at this point is significant, the Monaghan viscosity undoes the contribution of the MLS interpolants, and one-point quadrature (colocation) is not accurate enough. Solutions to these difficulties are being pursued vigorously.« less
Resolved simulations of a granular-fluid flow through a check dam with a SPH-DCDEM model
NASA Astrophysics Data System (ADS)
Birjukovs Canelas, Ricardo; Domínguez, Jose; Crespo, Alejandro; Gómez-Gesteira, Moncho; Ferreira, Rui M. L.
2017-04-01
Debris flows represent some of the most relevant phenomena in geomorphological events. Due to the potential destructiveness of such flows, they are the target of a vast amount of research. Experimental research in laboratory facilities or in the field is fundamental to characterize the fundamental rheological properties of these flows and to provide insights on its structure. However, characterizing interparticle contacts and the structure of the motion of the granular phase is difficult, even in controlled laboratory conditions, and possible only for simple geometries. This work addresses the need for a numerical simulation tool applicable to granular-fluid mixtures featuring high spatial and temporal resolution, thus capable of resolving the motion of individual particles, including all interparticle contacts and susceptible to complement laboratory research. The DualSPHysics meshless numerical implementation based on Smoothed Particle Hydrodynamics (SPH) is expanded with a Distributed Contact Discrete Element Method (DCDEM) in order to explicitly solve the fluid and the solid phase. The specific objective is to test the SPH-DCDEM approach by comparing its results with experimental data. An experimental set-up for stony debris flows in a slit check dam is reproduced numerically, where solid material is introduced through a hopper assuring a constant solid discharge for the considered time interval. With each sediment particle possibly undergoing several simultaneous contacts, thousands of time-evolving interactions are efficiently treated due to the model's algorithmic structure and the HPC implementation of DualSPHysics. The results, comprising mainly of retention curves, are in good agreement with the measurements, correctly reproducing the changes in efficiency with slit spacing and density. The encouraging results, coupled with the prospect of so far unique insights into the internal dynamics of a debris flow show the potential of high-performance resolved
Validation Data and Model Development for Fuel Assembly Response to Seismic Loads
DOE Office of Scientific and Technical Information (OSTI.GOV)
Bardet, Philippe; Ricciardi, Guillaume
2016-01-31
Vibrations are inherently present in nuclear reactors, especially in cores and steam generators of pressurized water reactors (PWR). They can have significant effects on local heat transfer and wear and tear in the reactor and often set safety margins. The simulation of these multiphysics phenomena from first principles requires the coupling of several codes, which is one the most challenging tasks in modern computer simulation. Here an ambitious multiphysics multidisciplinary validation campaign is conducted. It relied on an integrated team of experimentalists and code developers to acquire benchmark and validation data for fluid-structure interaction codes. Data are focused on PWRmore » fuel bundle behavior during seismic transients.« less
DOE Office of Scientific and Technical Information (OSTI.GOV)
Dass, Amala; Theivendran, Shevanuja; Nimmala, Praneeth Reddy
2015-04-15
Crystal structure determination has revolutionized modern science in biology, chemistry, and physics. However, the difficulty in obtaining periodic crystal lattices which are needed for X-ray crystal analysis has hindered the determination of atomic structure in nanomaterials, known as the “nanostructure problem”. Here, by using rigid and bulky ligands, we have overcome this limitation and successfully solved the X-ray crystallographic structure of the largest reported thiolated gold nanomolecule, Au133S52. The total composition, Au133(SPh-tBu)52, was verified using high resolution electrospray ionization mass spectrometry (ESI-MS). The experimental and simulated optical spectra show an emergent surface plasmon resonance that is more pronounced than inmore » the slightly larger Au144(SCH2CH2Ph)60. Theoretical analysis indicates that the presence of rigid and bulky ligands is the key to the successful crystal formation.« less
DOE Office of Scientific and Technical Information (OSTI.GOV)
Dass, Amala; Theivendran, Shevanuja; Nimmala, Praneeth Reddy
2015-04-15
Crystal structure determination has revolutionized modern science in biology, chemistry, and physics. However, the difficulty in obtaining periodic crystal lattices which are needed for X-ray crystal analysis has hindered the determination of atomic structure in nanomaterials, known as the "nanostructure problem". Here, by using rigid and bulky ligands, we have overcome this limitation and successfully solved the X-ray crystallographic structure of the largest reported thiolated gold nanomolecule, Au133S52. The total composition, Au-133(SPh-tBu)(52), was verified using high resolution electrospray ionization mass spectrometry (ESI-MS). The experimental and simulated optical spectra show an emergent surface plasmon resonance that is more pronounced than inmore » the slightly larger Au-144(SCH2CH2Ph)(60). Theoretical analysis indicates that the presence of rigid and bulky ligands is the key to the successful crystal formation.« less
Integration of UAV photogrammetry and SPH modelling of fluids to study runoff on real terrains.
Barreiro, Anxo; Domínguez, Jose M; C Crespo, Alejandro J; González-Jorge, Higinio; Roca, David; Gómez-Gesteira, Moncho
2014-01-01
Roads can experience runoff problems due to the intense rain discharge associated to severe storms. Two advanced tools are combined to analyse the interaction of complex water flows with real terrains. UAV (Unmanned Aerial Vehicle) photogrammetry is employed to obtain accurate topographic information on small areas, typically on the order of a few hectares. The Smoothed Particle Hydrodynamics (SPH) technique is applied by means of the DualSPHysics model to compute the trajectory of the water flow during extreme rain events. The use of engineering solutions to palliate flood events is also analysed. The study case simulates how the collected water can flow into a close road and how precautionary measures can be effective to drain water under extreme conditions. The amount of water arriving at the road is calculated under different protection scenarios and the efficiency of a ditch is observed to decrease when sedimentation reduces its depth.
Integration of UAV Photogrammetry and SPH Modelling of Fluids to Study Runoff on Real Terrains
Barreiro, Anxo; Domínguez, Jose M.; C. Crespo, Alejandro J.; González-Jorge, Higinio; Roca, David; Gómez-Gesteira, Moncho
2014-01-01
Roads can experience runoff problems due to the intense rain discharge associated to severe storms. Two advanced tools are combined to analyse the interaction of complex water flows with real terrains. UAV (Unmanned Aerial Vehicle) photogrammetry is employed to obtain accurate topographic information on small areas, typically on the order of a few hectares. The Smoothed Particle Hydrodynamics (SPH) technique is applied by means of the DualSPHysics model to compute the trajectory of the water flow during extreme rain events. The use of engineering solutions to palliate flood events is also analysed. The study case simulates how the collected water can flow into a close road and how precautionary measures can be effective to drain water under extreme conditions. The amount of water arriving at the road is calculated under different protection scenarios and the efficiency of a ditch is observed to decrease when sedimentation reduces its depth. PMID:25372035
Curing of Thick Thermoset Composite Laminates: Multiphysics Modeling and Experiments
NASA Astrophysics Data System (ADS)
Anandan, S.; Dhaliwal, G. S.; Huo, Z.; Chandrashekhara, K.; Apetre, N.; Iyyer, N.
2017-11-01
Fiber reinforced polymer composites are used in high-performance aerospace applications as they are resistant to fatigue, corrosion free and possess high specific strength. The mechanical properties of these composite components depend on the degree of cure and residual stresses developed during the curing process. While these parameters are difficult to determine experimentally in large and complex parts, they can be simulated using numerical models in a cost-effective manner. These simulations can be used to develop cure cycles and change processing parameters to obtain high-quality parts. In the current work, a numerical model was built in Comsol MultiPhysics to simulate the cure behavior of a carbon/epoxy prepreg system (IM7/Cycom 5320-1). A thermal spike was observed in thick laminates when the recommended cure cycle was used. The cure cycle was modified to reduce the thermal spike and maintain the degree of cure at the laminate center. A parametric study was performed to evaluate the effect of air flow in the oven, post cure cycles and cure temperatures on the thermal spike and the resultant degree of cure in the laminate.
Lv, Xing; Dai, Guoying; Lv, Gaohong; Chen, Yuping; Wu, Yunhao; Shen, Hongsheng; Xu, Huiqin
2016-06-05
Rehmanniae Radix (RR) and Cornus officinalis (CO) are two traditional Chinese medicines widely used in China for treating diabetes mellitus and its complications, such as diabetic nephropathy. Iridoid glycoside of Cornus officinalis (IGCO), triterpenoid acid of Cornus officinalis (TACO) and iridoid glycoside of Rehmanniae Radix (IGRR) formed an innovative formula named combinatorial bioactive parts (CBP). The aims of the present study were to investigate the renoprotective effects of CBP on DN through the inhibition of AGEs/RAGE/SphK1 signaling pathway activation, and identify the advantage of CBP compared with IGCO, TACO, IGRR. The db/db diabetic renal injury model was used to examine the renoprotective effects of CBP, IGCO, TACO and IGRR. For mechanistic studies, diabetic symptoms, renal functions, and pathohistology of pancreas and kidney were evaluated. AGEs/RAGE/SphK1 pathway were determined. CBP, IGCO, TACO and IGRR inhibited the decrease in serum insulin levels and the increases in urine volume, food consumption, water intake, TC, TG, glycated serum protein, fasting blood glucose levels, 24h urine protein levels, and serum levels of urea nitrogen and creatinine. It also prevented ECM accumulation and improved the histology of pancreas and kidney, and alleviated the structural alterations in mesangial cells and podocytes in renal cortex. Moreover, CBP, IGCO, TACO and IGRR down-regulated the elevated staining, protein levels of RAGE, SphK1, TGF-β and NF-κB. Among the treatment groups, CBP produced the strongest effects. These findings suggest that the inhibitory effect of CBP, IGCO, TACO and IGRR on the activation of AGEs/RAGE/SphK1 signaling pathway in db/db diabetic mice kidney is a novel mechanism by which CBP, IGCO, TACO and IGRR exerts renoprotective effects on DN. Among all the groups, CBP produced the strongest effect while IGCO, TACO and IGRR produced weaker effects. Copyright © 2016 Elsevier Ireland Ltd. All rights reserved.
Audigier, Chloé; Mansi, Tommaso; Delingette, Hervé; Rapaka, Saikiran; Passerini, Tiziano; Mihalef, Viorel; Jolly, Marie-Pierre; Pop, Raoul; Diana, Michele; Soler, Luc; Kamen, Ali; Comaniciu, Dorin; Ayache, Nicholas
2017-09-01
We aim at developing a framework for the validation of a subject-specific multi-physics model of liver tumor radiofrequency ablation (RFA). The RFA computation becomes subject specific after several levels of personalization: geometrical and biophysical (hemodynamics, heat transfer and an extended cellular necrosis model). We present a comprehensive experimental setup combining multimodal, pre- and postoperative anatomical and functional images, as well as the interventional monitoring of intra-operative signals: the temperature and delivered power. To exploit this dataset, an efficient processing pipeline is introduced, which copes with image noise, variable resolution and anisotropy. The validation study includes twelve ablations from five healthy pig livers: a mean point-to-mesh error between predicted and actual ablation extent of 5.3 ± 3.6 mm is achieved. This enables an end-to-end preclinical validation framework that considers the available dataset.
A study of solid wall models for weakly compressible SPH
DOE Office of Scientific and Technical Information (OSTI.GOV)
Valizadeh, Alireza, E-mail: alireza.valizadeh@monash.edu; Monaghan, Joseph J., E-mail: joe.monaghan@monash.edu
2015-11-01
This paper is concerned with a comparison of two methods of treating solid wall boundaries in the weakly compressible (SPH) method. They have been chosen because of their wide use in simulations. These methods are the boundary force particles of Monaghan and Kajtar [24] and the use of layers of fixed boundary particles. The latter was first introduced by Morris et al. [26] but has since been improved by Adami et al. [1] whose algorithm involves interpolating the pressure and velocity from the actual fluid to the boundary particles. For each method, we study the effect of the density diffusivemore » terms proposed by Molteni and Colagrossi [19] and modified by Antuono et al. [3]. We test the methods by a series of simulations commencing with the time-dependent spin-down of fluid within a cylinder and the behaviour of fluid in a box subjected to constant acceleration at an angle to the walls of the box, and concluding with a dam break over a triangular obstacle. In the first two cases the results from the two methods can be compared to analytical solutions while, in the latter case, they can be compared with experiments and other methods. These results show that the method of Adami et al. together with density diffusion is in very satisfactory agreement with the experimental results and is, overall, the best of the methods discussed here.« less
Development of a dynamic coupled hydro-geomechanical code and its application to induced seismicity
NASA Astrophysics Data System (ADS)
Miah, Md Mamun
This research describes the importance of a hydro-geomechanical coupling in the geologic sub-surface environment from fluid injection at geothermal plants, large-scale geological CO2 sequestration for climate mitigation, enhanced oil recovery, and hydraulic fracturing during wells construction in the oil and gas industries. A sequential computational code is developed to capture the multiphysics interaction behavior by linking a flow simulation code TOUGH2 and a geomechanics modeling code PyLith. Numerical formulation of each code is discussed to demonstrate their modeling capabilities. The computational framework involves sequential coupling, and solution of two sub-problems- fluid flow through fractured and porous media and reservoir geomechanics. For each time step of flow calculation, pressure field is passed to the geomechanics code to compute effective stress field and fault slips. A simplified permeability model is implemented in the code that accounts for the permeability of porous and saturated rocks subject to confining stresses. The accuracy of the TOUGH-PyLith coupled simulator is tested by simulating Terzaghi's 1D consolidation problem. The modeling capability of coupled poroelasticity is validated by benchmarking it against Mandel's problem. The code is used to simulate both quasi-static and dynamic earthquake nucleation and slip distribution on a fault from the combined effect of far field tectonic loading and fluid injection by using an appropriate fault constitutive friction model. Results from the quasi-static induced earthquake simulations show a delayed response in earthquake nucleation. This is attributed to the increased total stress in the domain and not accounting for pressure on the fault. However, this issue is resolved in the final chapter in simulating a single event earthquake dynamic rupture. Simulation results show that fluid pressure has a positive effect on slip nucleation and subsequent crack propagation. This is confirmed by
A 3D smoothed particle hydrodynamics model for erosional dam-break floods
NASA Astrophysics Data System (ADS)
Amicarelli, Andrea; Kocak, Bozhana; Sibilla, Stefano; Grabe, Jürgen
2017-11-01
A mesh-less smoothed particle hydrodynamics (SPH) model for bed-load transport on erosional dam-break floods is presented. This mixture model describes both the liquid phase and the solid granular material. The model is validated on the results from several experiments on erosional dam breaks. A comparison between the present model and a 2-phase SPH model for geotechnical applications (Gadget Soil; TUHH) is performed. A demonstrative 3D erosional dam break on complex topography is investigated. The present 3D mixture model is characterised by: no tuning parameter for the mixture viscosity; consistency with the Kinetic Theory of Granular Flow; ability to reproduce the evolution of the free surface and the bed-load transport layer; applicability to practical problems in civil engineering. The numerical developments of this study are represented by a new SPH scheme for bed-load transport, which is implemented in the SPH code SPHERA v.8.0 (RSE SpA), distributed as FOSS on GitHub.
NASA Technical Reports Server (NTRS)
Clementel, N.; Madura, T. I.; Kruip, C. J. H.; Icke, V.; Gull, T. R.
2014-01-01
Eta Carinae is an ideal astrophysical laboratory for studying massive binary interactions and evolution, and stellar wind-wind collisions. Recent three-dimensional (3D) simulations set the stage for understanding the highly complex 3D flows in Eta Car. Observations of different broad high- and low-ionization forbidden emission lines provide an excellent tool to constrain the orientation of the system, the primary's mass-loss rate, and the ionizing flux of the hot secondary. In this work we present the first steps towards generating synthetic observations to compare with available and future HST/STIS data. We present initial results from full 3D radiative transfer simulations of the interacting winds in Eta Car. We use the SimpleX algorithm to post-process the output from 3D SPH simulations and obtain the ionization fractions of hydrogen and helium assuming three different mass-loss rates for the primary star. The resultant ionization maps of both species constrain the regions where the observed forbidden emission lines can form. Including collisional ionization is necessary to achieve a better description of the ionization states, especially in the areas shielded from the secondary's radiation. We find that reducing the primary's mass-loss rate increases the volume of ionized gas, creating larger areas where the forbidden emission lines can form. We conclude that post processing 3D SPH data with SimpleX is a viable tool to create ionization maps for Eta Car.
NASA Technical Reports Server (NTRS)
Clementel, N.; Madura, T. I.; Kruip, C.J.H.; Icke, V.; Gull, T. R.
2014-01-01
Eta Carinae is an ideal astrophysical laboratory for studying massive binary interactions and evolution, and stellar wind-wind collisions. Recent three-dimensional (3D) simulations set the stage for understanding the highly complex 3D flows in eta Car. Observations of different broad high- and low-ionization forbidden emission lines provide an excellent tool to constrain the orientation of the system, the primary's mass-loss rate, and the ionizing flux of the hot secondary. In this work we present the first steps towards generating synthetic observations to compare with available and future HST/STIS data. We present initial results from full 3D radiative transfer simulations of the interacting winds in eta Car.We use the SimpleX algorithm to post-process the output from 3D SPH simulations and obtain the ionization fractions of hydrogen and helium assuming three different mass-loss rates for the primary star. The resultant ionization maps of both species constrain the regions where the observed forbidden emission lines can form. Including collisional ionization is necessary to achieve a better description of the ionization states, especially in the areas shielded from the secondary's radiation. We find that reducing the primary's mass-loss rate increases the volume of ionized gas, creating larger areas where the forbidden emission lines can form.We conclude that post processing 3D SPH data with SimpleX is a viable tool to create ionization maps for eta Car.
Interfacial mixing in high energy-density matter with a multiphysics kinetic model
NASA Astrophysics Data System (ADS)
Haack, Jeff; Hauck, Cory; Murillo, Michael
2017-10-01
We have extended a recently-developed multispecies, multitemperature BGK model to include multiphysics capability that allows modeling of a wider range of plasma conditions. In particular, we have extended the model to describe one spatial dimension, and included a multispecies atomic ionization model, accurate collision physics across coupling regimes, self-consistent electric fields, and degeneracy in the electronic screening. We apply the new model to a warm dense matter scenario in which the ablator-fuel interface of an inertial confinement fusion target is heated, similar to a recent molecular dynamics study, but for larger length and time scales and for much higher temperatures. From our numerical results we are able to explore a variety of phenomena, including hydrogen jetting, kinetic effects (non-Maxwellian and anisotropic distributions), plasma physics (size, persistence and role of electric fields) and transport (relative sizes of Fickean diffision, electrodiffusion and barodiffusion). As compared with the recent molecular dynamics work the kinetic model greatly extends the accessible physical domains we are able to model.
NASA Astrophysics Data System (ADS)
Zainol, M. R. R. M. A.; Kamaruddin, M. A.; Zawawi, M. H.; Wahab, K. A.
2017-11-01
Smooth Particle Hydrodynamic is the three-dimensional (3D) model. In this research work, three cases and one validation have been simulate using DualSPHysics. Study area of this research work was at Sarawak Barrage. The cases have different water level at the downstream. This study actually to simulate riverbed erosion and scouring properties by using multi-phases cases which use sand as sediment and water. The velocity and the scouring profile have been recorded as the result and shown in the result chapter. The result of the validation is acceptable where the scouring profile and the velocity were slightly different between laboratory experiment and simulation. Hence, it can be concluded that the simulation by using SPH can be used as the alternative to simulate the real cases.
Méningiome en plaque sphéno-orbitaire: à propos d'un cas avec revue de la littérature
Abdellaoui, Meriem; Andaloussi, Idriss Benatiya; Tahri, Hicham
2015-01-01
Le méningiome intra osseux est une variété des méningiomes ectopiques dans lequel les cellules méningothéliales envahissent la paroi osseuse et entraînent une hyperostose. Le méningiome en plaque, variante macroscopique des méningiomes intra osseux, est une tumeur rare et survient fréquemment au niveau de la région sphéno-orbitaire ce qui le confond avec les tumeurs osseuses primitives. Nous rapportons le cas d'une patiente de 50 ans qui présente une exophtalmie avec cécité unilatérale gauche d'installation progressive depuis un an. L'examen trouve une exophtalmie axile, indolore et non réductible ainsi qu'une limitation de la motilité oculaire dans tous les sens du regard. La palpation montre une masse temporale gauche dure et adhérente à l'os. L'examen du fond d’œil trouve un œdème papillaire gauche. Le scanner montre une lésion ostéocondensante temporo-sphéno-orbitaire gauche avec envahissement locorégional. Le diagnostic préopératoire fut une tumeur osseuse essentiellement maligne primitive ou secondaire. L’étude histologique a révélée un méningiome meningothélial de type en plaque. La patiente a bénéficié d'une exérèse avec reconstruction chirurgicale. Aucune récidive n'a été notée après 1 an de recul. PMID:26327996
A New Low Mass for the Hercules dSph: The End of a Common Mass Scale for the Dwarfs?
NASA Astrophysics Data System (ADS)
Adén, D.; Wilkinson, M. I.; Read, J. I.; Feltzing, S.; Koch, A.; Gilmore, G. F.; Grebel, E. K.; Lundström, I.
2009-11-01
We present a new mass estimate for the Hercules dwarf spheroidal (dSph) galaxy, based on the revised velocity dispersion obtained by Adén et al. The removal of a significant foreground contamination using newly acquired Strömgren photometry has resulted in a reduced velocity dispersion. Using this new velocity dispersion of 3.72 ± 0.91 km s-1, we find a mass of M 300 = 1.9+1.1 -0.8 × 106 M sun within the central 300 pc, which is also the half-light radius, and a mass of M 433 = 3.7+2.2 -1.6 × 106 M sun within the reach of our data to 433 pc, significantly lower than previous estimates. We derive an overall mass-to-light ratio of M 433/L = 103+83 -48[M sun/L sun]. Our mass estimate calls into question recent claims of a common mass scale for dSph galaxies. Additionally, we find tentative evidence for a velocity gradient in our kinematic data of 16 ± 3 km s-1 kpc-1, and evidence of an asymmetric extension in the light distribution at ~0.5 kpc. We explore the possibility that these features are due to tidal interactions with the Milky Way. We show that there is a self-consistent model in which Hercules has an assumed tidal radius of rt = 485 pc, an orbital pericenter of rp = 18.5 ± 5 kpc, and a mass within rt of M_{tid,r_t}=5.2_{-2.7}^{+2.7} × 10^6 M_⊙. Proper motions are required to test this model. Although we cannot exclude models in which Hercules contains no dark matter, we argue that Hercules is more likely to be a dark-matter-dominated system that is currently experiencing some tidal disturbance of its outer parts.
NASA Astrophysics Data System (ADS)
Deng, Hongping; Mayer, Lucio; Meru, Farzana
2017-09-01
We carry out simulations of gravitationally unstable disks using smoothed particle hydrodynamics (SPH) and the novel Lagrangian meshless finite mass (MFM) scheme in the GIZMO code. Our aim is to understand the cause of the nonconvergence of the cooling boundary for fragmentation reported in the literature. We run SPH simulations with two different artificial viscosity implementations and compare them with MFM, which does not employ any artificial viscosity. With MFM we demonstrate convergence of the critical cooling timescale for fragmentation at {β }{crit}≈ 3. Nonconvergence persists in SPH codes. We show how the nonconvergence problem is caused by artificial fragmentation triggered by excessive dissipation of angular momentum in domains with large velocity derivatives. With increased resolution, such domains become more prominent. Vorticity lags behind density, due to numerical viscous dissipation in these regions, promoting collapse with longer cooling times. Such effect is shown to be dominant over the competing tendency of artificial viscosity to diminish with increasing resolution. When the initial conditions are first relaxed for several orbits, the flow is more regular, with lower shear and vorticity in nonaxisymmetric regions, aiding convergence. Yet MFM is the only method that converges exactly. Our findings are of general interest, as numerical dissipation via artificial viscosity or advection errors can also occur in grid-based codes. Indeed, for the FARGO code values of {β }{crit} significantly higher than our converged estimate have been reported in the literature. Finally, we discuss implications for giant planet formation via disk instability.
NASA Technical Reports Server (NTRS)
Madura, Thomas I.; Gull, Theodore R.; Owocki, Stanley P.; Okazaki, Atsuo T.; Russell, Christopher M. P.
2010-01-01
The extremely massive (> 90 Solar Mass) and luminous (= 5 x 10(exp 6) Solar Luminosity) star Eta Carinae, with its spectacular bipolar "Homunculus" nebula, comprises one of the most remarkable and intensely observed stellar systems in the galaxy. However, many of its underlying physical parameters remain a mystery. Multiwavelength variations observed to occur every 5.54 years are interpreted as being due to the collision of a massive wind from the primary star with the fast, less dense wind of a hot companion star in a highly elliptical (e approx. 0.9) orbit. Using three-dimensional (3-D) Smoothed Particle Hydrodynamics (SPH) simulations of the binary wind-wind collision in Eta Car, together with radiative transfer codes, we compute synthetic spectral images of [Fe III] emission line structures and compare them to existing Hubble Space Telescope/Space Telescope Imaging Spectrograph (HST/STIS) observations. We are thus able, for the first time, to constrain the absolute orientation of the binary orbit on the sky. An orbit with an inclination of i approx. 40deg, an argument of periapsis omega approx. 255deg, and a projected orbital axis with a position angle of approx. 312deg east of north provides the best fit to the observations, implying that the orbital axis is closely aligned in 3-1) space with the Homunculus symmetry axis, and that the companion star orbits clockwise on the sky relative to the primary.
Algarra, Andrés G; Basallote, Manuel G; Fernandez-Trujillo, M J; Llusar, Rosa; Pino-Chamorro, Jose A; Sorribes, Ivan; Vicent, Cristian
2010-04-21
The synthesis, crystal structure and solution characterization of the cubane-type [Mo(3)(FeCl)S(4)(dmpe)(3)Cl(3)] (1) (dmpe = 1,2-bis(dimethylphophane-ethane)) cluster are reported and the ligand substitution processes of chloride by thiophenolate investigated. The kinetics and the intimate mechanism of these substitutions reveal that compound 1 undergoes a number of Fe and Mo site specific ligand substitution reactions in acetonitrile solutions. In particular, PhS(-) coordination at the tetrahedral Fe site proceeds in a single resolved kinetic step whereas such substitutions at the Mo sites proceed more slowly. The effect of the presence of acids in the reaction media is also investigated and reveals that an acid excess hinders substitution reactions both at the Fe and Mo sites; however, an acid-promoted solvolysis of the Fe-Cl bonds is observed. Electrospray ionization (ESI) and tandem (ESI-MS/MS) mass spectrometry allow the identification of all the reaction intermediates proposed on the basis of stopped-flow measurements. The distinctive site specific reactivity made it possible to isolate two new clusters of the Mo(3)FeS(4)(4+) family featuring mixed chlorine/thiophenolate ligands, namely Mo(3)S(4)(FeSPh)(dmpe)(3)Cl(3) (2) and [Mo(3)S(4)(FeSPh)(dmpe)(3)(SPh)(3)] (3). A detailed computational study has also been carried out to understand the details of the mechanism of substitution at the M-Cl (M = Mo and Fe) bonds as well as the solvolysis at the Fe-Cl sites, with particular emphasis on the role of acids on the substitution process. The results of the calculations are in agreement with the experimental observations, thus justifying the non-existence of an accelerating effect of acids on the thiophenolate substitution reaction, which differs from previous proposals for the Fe(4)S(4) and MoFe(3)S(4) clusters and some related compounds.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Ortensi, Javier; Baker, Benjamin Allen; Schunert, Sebastian
The INL is currently evolving the modeling and simulation (M&S) capability that will enable improved core operation as well as design and analysis of TREAT experiments. This M&S capability primarily uses MAMMOTH, a reactor physics application being developed under Multi-physics Object Oriented Simulation Environment (MOOSE) framework. MAMMOTH allows the coupling of a number of other MOOSE-based applications. This second year of work has been devoted to the generation of a deterministic reference solution for the full core, the preparation of anisotropic diffusion coefficients, the testing of the SPH equivalence method, and the improvement of the control rod modeling. In addition,more » this report includes the progress made in the modeling of the M8 core configuration and experiment vehicle since January of this year.« less
Giurgiutiu, Victor
2017-01-01
Piezoelectric wafer active sensors (PWAS) are commonly used for detecting Lamb waves for structural health monitoring application. However, in most applications of active sensing, the signals are of high-amplitude and easy to detect. In this article, we have shown a new avenue of using the PWAS transducer for detecting the low-amplitude fatigue-crack related acoustic emission (AE) signals. Multiphysics finite element (FE) simulations were performed with two PWAS transducers bonded to the structure. Various configurations of the sensors were studied by using the simulations. One PWAS was placed near to the fatigue-crack and the other one was placed at a certain distance from the crack. The simulated AE event was generated at the crack tip. The simulation results showed that both PWAS transducers were capable of sensing the AE signals. To validate the multiphysics simulation results, an in-situ AE-fatigue experiment was performed. Two PWAS transducers were bonded to the thin aerospace test coupon. The fatigue crack was generated in the test coupon which had produced low-amplitude acoustic waves. The low-amplitude fatigue-crack related AE signals were successfully captured by the PWAS transducers. The distance effect on the captured AE signals was also studied. It has been shown that some high-frequency contents of the AE signal have developed as they travel away from the crack. PMID:28817081
DOE Office of Scientific and Technical Information (OSTI.GOV)
Schultz, Peter Andrew
The objective of the U.S. Department of Energy Office of Nuclear Energy Advanced Modeling and Simulation Waste Integrated Performance and Safety Codes (NEAMS Waste IPSC) is to provide an integrated suite of computational modeling and simulation (M&S) capabilities to quantitatively assess the long-term performance of waste forms in the engineered and geologic environments of a radioactive-waste storage facility or disposal repository. Achieving the objective of modeling the performance of a disposal scenario requires describing processes involved in waste form degradation and radionuclide release at the subcontinuum scale, beginning with mechanistic descriptions of chemical reactions and chemical kinetics at the atomicmore » scale, and upscaling into effective, validated constitutive models for input to high-fidelity continuum scale codes for coupled multiphysics simulations of release and transport. Verification and validation (V&V) is required throughout the system to establish evidence-based metrics for the level of confidence in M&S codes and capabilities, including at the subcontiunuum scale and the constitutive models they inform or generate. This Report outlines the nature of the V&V challenge at the subcontinuum scale, an approach to incorporate V&V concepts into subcontinuum scale modeling and simulation (M&S), and a plan to incrementally incorporate effective V&V into subcontinuum scale M&S destined for use in the NEAMS Waste IPSC work flow to meet requirements of quantitative confidence in the constitutive models informed by subcontinuum scale phenomena.« less
Polwaththe-Gallage, Hasitha-Nayanajith; Saha, Suvash C; Sauret, Emilie; Flower, Robert; Senadeera, Wijitha; Gu, YuanTong
2016-12-28
Blood continuously flows through the blood vessels in the human body. When blood flows through the smallest blood vessels, red blood cells (RBCs) in the blood exhibit various types of motion and deformed shapes. Computational modelling techniques can be used to successfully predict the behaviour of the RBCs in capillaries. In this study, we report the application of a meshfree particle approach to model and predict the motion and deformation of three-dimensional RBCs in capillaries. An elastic spring network based on the discrete element method (DEM) is employed to model the three-dimensional RBC membrane. The haemoglobin in the RBC and the plasma in the blood are modelled as smoothed particle hydrodynamics (SPH) particles. For validation purposes, the behaviour of a single RBC in a simple shear flow is examined and compared against experimental results. Then simulations are carried out to predict the behaviour of RBCs in a capillary; (i) the motion of five identical RBCs in a uniform capillary, (ii) the motion of five identical RBCs with different bending stiffness (K b ) values in a stenosed capillary, (iii) the motion of three RBCs in a narrow capillary. Finally five identical RBCs are employed to determine the critical diameter of a stenosed capillary. Validation results showed a good agreement with less than 10% difference. From the above simulations, the following results are obtained; (i) RBCs exhibit different deformation behaviours due to the hydrodynamic interaction between them. (ii) Asymmetrical deformation behaviours of the RBCs are clearly observed when the bending stiffness (K b ) of the RBCs is changed. (iii) The model predicts the ability of the RBCs to squeeze through smaller blood vessels. Finally, from the simulations, the critical diameter of the stenosed section to stop the motion of blood flow is predicted. A three-dimensional spring network model based on DEM in combination with the SPH method is successfully used to model the motion and
PowderSim: Lagrangian Discrete and Mesh-Free Continuum Simulation Code for Cohesive Soils
NASA Technical Reports Server (NTRS)
Johnson, Scott; Walton, Otis; Settgast, Randolph
2013-01-01
PowderSim is a calculation tool that combines a discrete-element method (DEM) module, including calibrated interparticle-interaction relationships, with a mesh-free, continuum, SPH (smoothed-particle hydrodynamics) based module that utilizes enhanced, calibrated, constitutive models capable of mimicking both large deformations and the flow behavior of regolith simulants and lunar regolith under conditions anticipated during in situ resource utilization (ISRU) operations. The major innovation introduced in PowderSim is to use a mesh-free method (SPH-based) with a calibrated and slightly modified critical-state soil mechanics constitutive model to extend the ability of the simulation tool to also address full-scale engineering systems in the continuum sense. The PowderSim software maintains the ability to address particle-scale problems, like size segregation, in selected regions with a traditional DEM module, which has improved contact physics and electrostatic interaction models.
A multi-physics analysis for the actuation of the SSS in opal reactor
NASA Astrophysics Data System (ADS)
Ferraro, Diego; Alberto, Patricio; Villarino, Eduardo; Doval, Alicia
2018-05-01
OPAL is a 20 MWth multi-purpose open-pool type Research Reactor located at Lucas Heights, Australia. It was designed, built and commissioned by INVAP between 2000 and 2006 and it has been operated by the Australia Nuclear Science and Technology Organization (ANSTO) showing a very good overall performance. On November 2016, OPAL reached 10 years of continuous operation, becoming one of the most reliable and available in its kind worldwide, with an unbeaten record of being fully operational 307 days a year. One of the enhanced safety features present in this state-of-art reactor is the availability of an independent, diverse and redundant Second Shutdown System (SSS), which consists in the drainage of the heavy water reflector contained in the Reflector Vessel. As far as high quality experimental data is available from reactor commissioning and operation stages and even from early component design validation stages, several models both regarding neutronic and thermo-hydraulic approaches have been developed during recent years using advanced calculations tools and the novel capabilities to couple them. These advanced models were developed in order to assess the capability of such codes to simulate and predict complex behaviours and develop highly detail analysis. In this framework, INVAP developed a three-dimensional CFD model that represents the detailed hydraulic behaviour of the Second Shutdown System for an actuation scenario, where the heavy water drainage 3D temporal profiles inside the Reflector Vessel can be obtained. This model was validated, comparing the computational results with experimental measurements performed in a real-size physical model built by INVAP during early OPAL design engineering stages. Furthermore, detailed 3D Serpent Monte Carlo models are also available, which have been already validated with experimental data from reactor commissioning and operating cycles. In the present work the neutronic and thermohydraulic models, available for
NASA Astrophysics Data System (ADS)
Massmann, J.; Nagel, T.; Bilke, L.; Böttcher, N.; Heusermann, S.; Fischer, T.; Kumar, V.; Schäfers, A.; Shao, H.; Vogel, P.; Wang, W.; Watanabe, N.; Ziefle, G.; Kolditz, O.
2016-12-01
As part of the German site selection process for a high-level nuclear waste repository, different repository concepts in the geological candidate formations rock salt, clay stone and crystalline rock are being discussed. An open assessment of these concepts using numerical simulations requires physical models capturing the individual particularities of each rock type and associated geotechnical barrier concept to a comparable level of sophistication. In a joint work group of the Helmholtz Centre for Environmental Research (UFZ) and the German Federal Institute for Geosciences and Natural Resources (BGR), scientists of the UFZ are developing and implementing multiphysical process models while BGR scientists apply them to large scale analyses. The advances in simulation methods for waste repositories are incorporated into the open-source code OpenGeoSys. Here, recent application-driven progress in this context is highlighted. A robust implementation of visco-plasticity with temperature-dependent properties into a framework for the thermo-mechanical analysis of rock salt will be shown. The model enables the simulation of heat transport along with its consequences on the elastic response as well as on primary and secondary creep or the occurrence of dilatancy in the repository near field. Transverse isotropy, non-isothermal hydraulic processes and their coupling to mechanical stresses are taken into account for the analysis of repositories in clay stone. These processes are also considered in the near field analyses of engineered barrier systems, including the swelling/shrinkage of the bentonite material. The temperature-dependent saturation evolution around the heat-emitting waste container is described by different multiphase flow formulations. For all mentioned applications, we illustrate the workflow from model development and implementation, over verification and validation, to repository-scale application simulations using methods of high performance computing.
NASA Technical Reports Server (NTRS)
Kilbane, J.; Polzin, K. A.
2014-01-01
An annular linear induction pump (ALIP) that could be used for circulating liquid-metal coolant in a fission surface power reactor system is modeled in the present work using the computational COMSOL Multiphysics package. The pump is modeled using a two-dimensional, axisymmetric geometry and solved under conditions similar to those used during experimental pump testing. Real, nonlinear, temperature-dependent material properties can be incorporated into the model for both the electrically-conducting working fluid in the pump (NaK-78) and structural components of the pump. The intricate three-phase coil configuration of the pump is implemented in the model to produce an axially-traveling magnetic wave that is qualitatively similar to the measured magnetic wave. The model qualitatively captures the expected feature of a peak in efficiency as a function of flow rate.
Lu, Tsai-Te; Chiou, Show-Jen; Chen, Chun-Yu; Liaw, Wen-Feng
2006-10-16
Nitrosylation of the biomimetic reduced- and oxidized-form rubredoxin [Fe(SR)4]2-/1- (R = Ph, Et) in a 1:1 stoichiometry led to the formation of the extremely air- and light-sensitive mononitrosyl tris(thiolate) iron complexes (MNICs) [Fe(NO)(SR)3]- along with byproducts [SR]- or (RS)2. Transformation of [Fe(NO)(SR)3]- into dinitrosyl iron complexes (DNICs) [(RS)2Fe(NO)2]- and Roussin's red ester [Fe2(mu-SR)2(NO)4] occurs rapidly under addition of 1 equiv of NO(g) and [NO]+, respectively. Obviously, the mononitrosyl tris(thiolate) complex [Fe(NO)(SR)3]- acts as an intermediate when the biomimetic oxidized- and reduced-form rubredoxin [Fe(SR)4]2-/1- exposed to NO(g) were modified to form dinitrosyl iron complexes [(RS)2Fe(NO)2]-. Presumably, NO binding to the electron-deficient [Fe(III)(SR)4]- and [Fe(III)(NO)(SR)3]- complexes triggers reductive elimination of dialkyl/diphenyl disulfide, while binding of NO radical to the reduced-form [Fe(II)(SR)4]2- induces the thiolate-ligand elimination. Protonation of [Fe(NO)(SEt)3]- yielding [Fe(NO)(SPh)3]- by adding 3 equiv of thiophenol and transformation of [Fe(NO)(SPh)3]- to [Fe(NO)(SEt)3]- in the presence of 3 equiv of [SEt]-, respectively, demonstrated that complexes [Fe(NO)(SPh)3]- and [Fe(NO)(SEt)3]- are chemically interconvertible. Mononitrosyl tris(thiolate) iron complex [Fe(NO)(SPh)3]- and dinitrosyl iron complex [(EtS)2Fe(NO)2]- were isolated and characterized by X-ray diffraction. The mean NO bond distances of 1.181(7) A (or 1.191(7) A) in complex [(EtS)2Fe(NO)2]- are nearly at the upper end of the 1.178(3)-1.160(6) A for the anionic {Fe(NO)2}9 DNICs, while the mean FeN(O) distances of 1.674(6) A (or 1.679(6) A) exactly fall in the range of 1.695(3)-1.661(4) A for the anionic {Fe(NO)2}9 DNICs.
NASA Astrophysics Data System (ADS)
Eghtesad, Adnan; Knezevic, Marko
2018-07-01
A corrective smooth particle method (CSPM) within smooth particle hydrodynamics (SPH) is used to study the deformation of an aircraft structure under high-velocity water-ditching impact load. The CSPM-SPH method features a new approach for the prediction of two-way fluid-structure interaction coupling. Results indicate that the implementation is well suited for modeling the deformation of structures under high-velocity impact into water as evident from the predicted stress and strain localizations in the aircraft structure as well as the integrity of the impacted interfaces, which show no artificial particle penetrations. To reduce the simulation time, a heterogeneous particle size distribution over a complex three-dimensional geometry is used. The variable particle size is achieved from a finite element mesh with variable element size and, as a result, variable nodal (i.e., SPH particle) spacing. To further accelerate the simulations, the SPH code is ported to a graphics processing unit using the OpenACC standard. The implementation and simulation results are described and discussed in this paper.
NASA Astrophysics Data System (ADS)
Eghtesad, Adnan; Knezevic, Marko
2017-12-01
A corrective smooth particle method (CSPM) within smooth particle hydrodynamics (SPH) is used to study the deformation of an aircraft structure under high-velocity water-ditching impact load. The CSPM-SPH method features a new approach for the prediction of two-way fluid-structure interaction coupling. Results indicate that the implementation is well suited for modeling the deformation of structures under high-velocity impact into water as evident from the predicted stress and strain localizations in the aircraft structure as well as the integrity of the impacted interfaces, which show no artificial particle penetrations. To reduce the simulation time, a heterogeneous particle size distribution over a complex three-dimensional geometry is used. The variable particle size is achieved from a finite element mesh with variable element size and, as a result, variable nodal (i.e., SPH particle) spacing. To further accelerate the simulations, the SPH code is ported to a graphics processing unit using the OpenACC standard. The implementation and simulation results are described and discussed in this paper.
Numerical Viscosity and the Survival of Gas Giant Protoplanets in Disk Simulations
NASA Astrophysics Data System (ADS)
Pickett, Megan K.; Durisen, Richard H.
2007-01-01
We present three-dimensional hydrodynamic simulations of a gravitationally unstable protoplanetary disk model under the condition of local isothermality. Ordinarily, local isothermality precludes the need for an artificial viscosity (AV) scheme to mediate shocks. Without AV, the disk evolves violently, shredding into dense (although short-lived) clumps. When we introduce our AV treatment in the momentum equation, but without heating due to irreversible compression, our grid-based simulations begin to resemble smoothed particle hydrodynamics (SPH) calculations, where clumps are more likely to survive many orbits. In fact, the standard SPH viscosity appears comparable in strength to the AV that leads to clump longevity in our code. This sensitivity to one numerical parameter suggests extreme caution in interpreting simulations by any code in which long-lived gaseous protoplanetary bodies appear.
Multi-Physics Simulation of TREAT Kinetics using MAMMOTH
DOE Office of Scientific and Technical Information (OSTI.GOV)
DeHart, Mark; Gleicher, Frederick; Ortensi, Javier
With the advent of next generation reactor systems and new fuel designs, the U.S. Department of Energy (DOE) has identified the need for the resumption of transient testing of nuclear fuels. DOE has decided that the Transient Reactor Test Facility (TREAT) at Idaho National Laboratory (INL) is best suited for future testing. TREAT is a thermal neutron spectrum nuclear test facility that is designed to test nuclear fuels in transient scenarios. These specific fuels transient tests range from simple temperature transients to full fuel melt accidents. The current TREAT core is driven by highly enriched uranium (HEU) dispersed in amore » graphite matrix (1:10000 U-235/C atom ratio). At the center of the core, fuel is removed allowing for the insertion of an experimental test vehicle. TREAT’s design provides experimental flexibility and inherent safety during neutron pulsing. This safety stems from the graphite in the driver fuel having a strong negative temperature coefficient of reactivity resulting from a thermal Maxwellian shift with increased leakage, as well as graphite acting as a temperature sink. Air cooling is available, but is generally used post-transient for heat removal. DOE and INL have expressed a desire to develop a simulation capability that will accurately model the experiments before they are irradiated at the facility, with an emphasis on effective and safe operation while minimizing experimental time and cost. At INL, the Multi-physics Object Oriented Simulation Environment (MOOSE) has been selected as the model development framework for this work. This paper describes the results of preliminary simulations of a TREAT fuel element under transient conditions using the MOOSE-based MAMMOTH reactor physics tool.« less
A multiscale SPH particle model of the near-wall dynamics of leukocytes in flow.
Gholami, Babak; Comerford, Andrew; Ellero, Marco
2014-01-01
A novel multiscale Lagrangian particle solver based on SPH is developed with the intended application of leukocyte transport in large arteries. In such arteries, the transport of leukocytes and red blood cells can be divided into two distinct regions: the bulk flow and the near-wall region. In the bulk flow, the transport can be modeled on a continuum basis as the transport of passive scalar concentrations. Whereas in the near-wall region, specific particle tracking of the leukocytes is required and lubrication forces need to be separately taken into account. Because of large separation of spatio-temporal scales involved in the problem, simulations of red blood cells and leukocytes are handled separately. In order to take the exchange of leukocytes between the bulk fluid and the near-wall region into account, solutions are communicated through coupling of conserved quantities at the interface between these regions. Because the particle tracking is limited to those leukocytes lying in the near-wall region only, our approach brings considerable speedup to the simulation of leukocyte circulation in a test geometry of a backward-facing step, which encompasses many flow features observed in vivo. Copyright © 2013 John Wiley & Sons, Ltd.
A NEW LOW MASS FOR THE HERCULES dSph: THE END OF A COMMON MASS SCALE FOR THE DWARFS?
DOE Office of Scientific and Technical Information (OSTI.GOV)
Aden, D.; Feltzing, S.; Lundstroem, I.
2009-11-20
We present a new mass estimate for the Hercules dwarf spheroidal (dSph) galaxy, based on the revised velocity dispersion obtained by Aden et al. The removal of a significant foreground contamination using newly acquired Stroemgren photometry has resulted in a reduced velocity dispersion. Using this new velocity dispersion of 3.72 +- 0.91 km s{sup -1}, we find a mass of M {sub 300} = 1.9{sup +1.1}{sub -0.8} x 10{sup 6} M{sub sun} within the central 300 pc, which is also the half-light radius, and a mass of M {sub 433} = 3.7{sup +2.2}{sub -1.6} x 10{sup 6} M{sub sun} withinmore » the reach of our data to 433 pc, significantly lower than previous estimates. We derive an overall mass-to-light ratio of M {sub 433}/L = 103{sup +83}{sub -48}[M{sub sun}/L{sub sun}]. Our mass estimate calls into question recent claims of a common mass scale for dSph galaxies. Additionally, we find tentative evidence for a velocity gradient in our kinematic data of 16 +- 3 km s{sup -1} kpc{sup -1}, and evidence of an asymmetric extension in the light distribution at approx0.5 kpc. We explore the possibility that these features are due to tidal interactions with the Milky Way. We show that there is a self-consistent model in which Hercules has an assumed tidal radius of r{sub t} = 485 pc, an orbital pericenter of r{sub p} = 18.5 +- 5 kpc, and a mass within r{sub t} of M{sub tid,r}=5.2{sup +2.7}{sub -2.7} x 10{sup 6} M-odot. Proper motions are required to test this model. Although we cannot exclude models in which Hercules contains no dark matter, we argue that Hercules is more likely to be a dark-matter-dominated system that is currently experiencing some tidal disturbance of its outer parts.« less
A multiphysics microstructure-resolved model for silicon anode lithium-ion batteries
NASA Astrophysics Data System (ADS)
Wang, Miao; Xiao, Xinran; Huang, Xiaosong
2017-04-01
Silicon (Si) is one of the most promising next generation anode materials for lithium-ion batteries (LIBs), but the use of Si in LIBs has been rather limited. The main challenge is its large volume change (up to 300%) during battery cycling. This can lead to the fracture of Si, failure at the interfaces between electrode components, and large dimensional change on the cell level. To optimize the Si electrode/battery design, a model that considers the interactions of different cell components is needed. This paper presents the development of a multiphysics microstructure-resolved model (MRM) for LIB cells with a-Si anode. The model considered the electrochemical reactions, Li transports in electrolyte and electrodes, dimensional changes and stresses, property evolution with the structure, and the coupling relationships. Important model parameters, such as the diffusivity, reaction rate constant, and apparent transfer coefficient, were determined by correlating the simulation results to experiments. The model was validated with experimental results in the literature. The use of this model was demonstrated in a parameter study of Si nanowall|Li cells. The specific and volumetric capacities of the cell as a function of the size, length/size ratio, spacing of the nanostructure, and Li+ concentration in electrolyte were investigated.
Design of a Modular Monolithic Implicit Solver for Multi-Physics Applications
NASA Technical Reports Server (NTRS)
Carton De Wiart, Corentin; Diosady, Laslo T.; Garai, Anirban; Burgess, Nicholas; Blonigan, Patrick; Ekelschot, Dirk; Murman, Scott M.
2018-01-01
The design of a modular multi-physics high-order space-time finite-element framework is presented together with its extension to allow monolithic coupling of different physics. One of the main objectives of the framework is to perform efficient high- fidelity simulations of capsule/parachute systems. This problem requires simulating multiple physics including, but not limited to, the compressible Navier-Stokes equations, the dynamics of a moving body with mesh deformations and adaptation, the linear shell equations, non-re effective boundary conditions and wall modeling. The solver is based on high-order space-time - finite element methods. Continuous, discontinuous and C1-discontinuous Galerkin methods are implemented, allowing one to discretize various physical models. Tangent and adjoint sensitivity analysis are also targeted in order to conduct gradient-based optimization, error estimation, mesh adaptation, and flow control, adding another layer of complexity to the framework. The decisions made to tackle these challenges are presented. The discussion focuses first on the "single-physics" solver and later on its extension to the monolithic coupling of different physics. The implementation of different physics modules, relevant to the capsule/parachute system, are also presented. Finally, examples of coupled computations are presented, paving the way to the simulation of the full capsule/parachute system.
Multiphysics Object-Oriented Simulation Environment (MOOSE)
None
2017-12-09
Nuclear reactor operators can expand safety margins with more precise information about how materials behave inside operating reactors. INL's new simulation platform makes such studies easier & more informative by letting researchers "plug-n-play" their mathematical models, skipping years of computer code development.
Modelling transport phenomena in a multi-physics context
NASA Astrophysics Data System (ADS)
Marra, Francesco
2015-01-01
Innovative heating research on cooking, pasteurization/sterilization, defrosting, thawing and drying, often focuses on areas which include the assessment of processing time, evaluation of heating uniformity, studying the impact on quality attributes of the final product as well as considering the energy efficiency of these heating processes. During the last twenty years, so-called electro-heating-processes (radio-frequency - RF, microwaves - MW and ohmic - OH) gained a wide interest in industrial food processing and many applications using the above mentioned technologies have been developed with the aim of reducing processing time, improving process efficiency and, in many cases, the heating uniformity. In the area of innovative heating, electro-heating accounts for a considerable portion of both the scientific literature and commercial applications, which can be subdivided into either direct electro-heating (as in the case of OH heating) where electrical current is applied directly to the food or indirect electro-heating (e.g. MW and RF heating) where the electrical energy is firstly converted to electromagnetic radiation which subsequently generates heat within a product. New software packages, which make easier solution of PDEs based mathematical models, and new computers, capable of larger RAM and more efficient CPU performances, allowed an increasing interest about modelling transport phenomena in systems and processes - as the ones encountered in food processing - that can be complex in terms of geometry, composition, boundary conditions but also - as in the case of electro-heating assisted applications - in terms of interaction with other physical phenomena such as displacement of electric or magnetic field. This paper deals with the description of approaches used in modelling transport phenomena in a multi-physics context such as RF, MW and OH assisted heating.
Modelling transport phenomena in a multi-physics context
DOE Office of Scientific and Technical Information (OSTI.GOV)
Marra, Francesco
2015-01-22
Innovative heating research on cooking, pasteurization/sterilization, defrosting, thawing and drying, often focuses on areas which include the assessment of processing time, evaluation of heating uniformity, studying the impact on quality attributes of the final product as well as considering the energy efficiency of these heating processes. During the last twenty years, so-called electro-heating-processes (radio-frequency - RF, microwaves - MW and ohmic - OH) gained a wide interest in industrial food processing and many applications using the above mentioned technologies have been developed with the aim of reducing processing time, improving process efficiency and, in many cases, the heating uniformity. Inmore » the area of innovative heating, electro-heating accounts for a considerable portion of both the scientific literature and commercial applications, which can be subdivided into either direct electro-heating (as in the case of OH heating) where electrical current is applied directly to the food or indirect electro-heating (e.g. MW and RF heating) where the electrical energy is firstly converted to electromagnetic radiation which subsequently generates heat within a product. New software packages, which make easier solution of PDEs based mathematical models, and new computers, capable of larger RAM and more efficient CPU performances, allowed an increasing interest about modelling transport phenomena in systems and processes - as the ones encountered in food processing - that can be complex in terms of geometry, composition, boundary conditions but also - as in the case of electro-heating assisted applications - in terms of interaction with other physical phenomena such as displacement of electric or magnetic field. This paper deals with the description of approaches used in modelling transport phenomena in a multi-physics context such as RF, MW and OH assisted heating.« less
Data-driven prognosis: a multi-physics approach verified via balloon burst experiment.
Chandra, Abhijit; Kar, Oliva
2015-04-08
A multi-physics formulation for data-driven prognosis (DDP) is developed. Unlike traditional predictive strategies that require controlled offline measurements or 'training' for determination of constitutive parameters to derive the transitional statistics, the proposed DDP algorithm relies solely on in situ measurements. It uses a deterministic mechanics framework, but the stochastic nature of the solution arises naturally from the underlying assumptions regarding the order of the conservation potential as well as the number of dimensions involved. The proposed DDP scheme is capable of predicting onset of instabilities. Because the need for offline testing (or training) is obviated, it can be easily implemented for systems where such a priori testing is difficult or even impossible to conduct. The prognosis capability is demonstrated here via a balloon burst experiment where the instability is predicted using only online visual observations. The DDP scheme never failed to predict the incipient failure, and no false-positives were issued. The DDP algorithm is applicable to other types of datasets. Time horizons of DDP predictions can be adjusted by using memory over different time windows. Thus, a big dataset can be parsed in time to make a range of predictions over varying time horizons.
Propagation of neutron-reaction uncertainties through multi-physics models of novel LWR's
NASA Astrophysics Data System (ADS)
Hernandez-Solis, Augusto; Sjöstrand, Henrik; Helgesson, Petter
2017-09-01
The novel design of the renewable boiling water reactor (RBWR) allows a breeding ratio greater than unity and thus, it aims at providing for a self-sustained fuel cycle. The neutron reactions that compose the different microscopic cross-sections and angular distributions are uncertain, so when they are employed in the determination of the spatial distribution of the neutron flux in a nuclear reactor, a methodology should be employed to account for these associated uncertainties. In this work, the Total Monte Carlo (TMC) method is used to propagate the different neutron-reactions (as well as angular distributions) covariances that are part of the TENDL-2014 nuclear data (ND) library. The main objective is to propagate them through coupled neutronic and thermal-hydraulic models in order to assess the uncertainty of important safety parameters related to multi-physics, such as peak cladding temperature along the axial direction of an RBWR fuel assembly. The objective of this study is to quantify the impact that ND covariances of important nuclides such as U-235, U-238, Pu-239 and the thermal scattering of hydrogen in H2O have in the deterministic safety analysis of novel nuclear reactors designs.
A templated approach for multi-physics modeling of hybrid energy systems in Modelica
DOE Office of Scientific and Technical Information (OSTI.GOV)
Greenwood, Michael Scott; Cetiner, Sacit M.; Harrison, Thomas J.
A prototypical hybrid energy system (HES) couples a primary thermal power generator (i.e., nuclear power plant) with one or more additional subsystems beyond the traditional balance of plant electricity generation system. The definition and architecture of an HES can be adapted based on the needs and opportunities of a given local market. For example, locations in need of potable water may be best served by coupling a desalination plant to the HES. A location near an oil refinery may have a need for emission-free hydrogen production. The flexible, multidomain capabilities of Modelica are being used to investigate the dynamics (e.g.,more » thermal hydraulics and electrical generation/consumption) of such a hybrid system. This paper examines the simulation infrastructure created to enable the coupling of multiphysics subsystem models for HES studies. A demonstration of a tightly coupled nuclear hybrid energy system implemented using the Modelica based infrastructure is presented for two representative cases. An appendix is also included providing a step-by-step procedure for using the template-based infrastructure.« less
Accurate Treatment of Collision and Water-Delivery in Models of Terrestrial Planet Formation
NASA Astrophysics Data System (ADS)
Haghighipour, N.; Maindl, T. I.; Schaefer, C. M.; Wandel, O.
2017-08-01
We have developed a comprehensive approach in simulating collisions and growth of embryos to terrestrial planets where we use a combination of SPH and N-body codes to model collisions and the transfer of water and chemical compounds accurately.
User Instructions for the EPIC-2 Code.
1986-09-01
10 1 TAM IIFAILIDARAC EFAIL 5 MATERIAL CARDS FOR SOLIDS INPUT DATA L45,5X, FSO, A48. R(8FDO.OJ, MATL I WAR I iAIL "EFAILMAtEA :SCRIPT ION DENSITY SPH...failure of the elements must be achieved by the eroding interface algorithm, it is important that EFAIL (a mate- rial property) be much greater than ERODE...If left blank (DFRAC z 0) factor will be set to DFRAC = 1.0 EFAIL = Equivalent plastic strain (true) which, if exceeded, will totally fail the element
FY17Q4 Ristra project: Release Version 1.0 of a production toolkit
DOE Office of Scientific and Technical Information (OSTI.GOV)
Hungerford, Aimee L.; Daniel, David John
2017-09-21
The Next Generation Code project will release Version 1.0 of a production toolkit for multi-physics application development on advanced architectures. Features of this toolkit will include remap and link utilities, control and state manager, setup, visualization and I/O, as well as support for a variety of mesh and particle data representations. Numerical physics packages that operate atop this foundational toolkit will be employed in a multi-physics demonstration problem and released to the community along with results from the demonstration.
Integration of OpenMC methods into MAMMOTH and Serpent
DOE Office of Scientific and Technical Information (OSTI.GOV)
Kerby, Leslie; DeHart, Mark; Tumulak, Aaron
OpenMC, a Monte Carlo particle transport simulation code focused on neutron criticality calculations, contains several methods we wish to emulate in MAMMOTH and Serpent. First, research coupling OpenMC and the Multiphysics Object-Oriented Simulation Environment (MOOSE) has shown promising results. Second, the utilization of Functional Expansion Tallies (FETs) allows for a more efficient passing of multiphysics data between OpenMC and MOOSE. Both of these capabilities have been preliminarily implemented into Serpent. Results are discussed and future work recommended.
NASA Astrophysics Data System (ADS)
Pawar, Sumedh; Sharma, Atul
2018-01-01
This work presents mathematical model and solution methodology for a multiphysics engineering problem on arc formation during welding and inside a nozzle. A general-purpose commercial CFD solver ANSYS FLUENT 13.0.0 is used in this work. Arc formation involves strongly coupled gas dynamics and electro-dynamics, simulated by solution of coupled Navier-Stoke equations, Maxwell's equations and radiation heat-transfer equation. Validation of the present numerical methodology is demonstrated with an excellent agreement with the published results. The developed mathematical model and the user defined functions (UDFs) are independent of the geometry and are applicable to any system that involves arc-formation, in 2D axisymmetric coordinates system. The high-pressure flow of SF6 gas in the nozzle-arc system resembles arc chamber of SF6 gas circuit breaker; thus, this methodology can be extended to simulate arcing phenomenon during current interruption.
Collisional disruptions of rotating targets
NASA Astrophysics Data System (ADS)
Ševeček, Pavel; Broz, Miroslav
2017-10-01
Collisions are key processes in the evolution of the Main Asteroid Belt and impact events - i.e. target fragmentation and gravitational reaccumulation - are commonly studied by numerical simulations, namely by SPH and N-body methods. In our work, we extend the previous studies by assuming rotating targets and we study the dependence of resulting size-distributions on the pre-impact rotation of the target. To obtain stable initial conditions, it is also necessary to include the self-gravity already in the fragmentation phase which was previously neglected.To tackle this problem, we developed an SPH code, accelerated by SSE/AVX instruction sets and parallelized. The code solves the standard set of hydrodynamic equations, using the Tillotson equation of state, von Mises criterion for plastic yielding and scalar Grady-Kipp model for fragmentation. We further modified the velocity gradient by a correction tensor (Schäfer et al. 2007) to ensure a first-order conservation of the total angular momentum. As the intact target is a spherical body, its gravity can be approximated by a potential of a homogeneous sphere, making it easy to set up initial conditions. This is however infeasible for later stages of the disruption; to this point, we included the Barnes-Hut algorithm to compute the gravitational accelerations, using a multipole expansion of distant particles up to hexadecapole order.We tested the code carefully, comparing the results to our previous computations obtained with the SPH5 code (Benz and Asphaug 1994). Finally, we ran a set of simulations and we discuss the difference between the synthetic families created by rotating and static targets.
Gholami, Babak; Comerford, Andrew; Ellero, Marco
2015-11-01
A multiscale Lagrangian particle solver introduced in our previous work is extended to model physiologically realistic near-wall cell dynamics. Three-dimensional simulation of particle trajectories is combined with realistic receptor-ligand adhesion behaviour to cover full cell interactions in the vicinity of the endothelium. The selected stochastic adhesion model, which is based on a Monte Carlo acceptance-rejection method, fits in our Lagrangian framework and does not compromise performance. Additionally, appropriate inflow/outflow boundary conditions are implemented for our SPH solver to enable realistic pulsatile flow simulation. The model is tested against in-vitro data from a 3D geometry with a stenosis and sudden expansion. In both steady and pulsatile flow conditions, results show close agreement with the experimental ones. Furthermore we demonstrate, in agreement with experimental observations, that haemodynamics alone does not account for adhesion of white blood cells, in this case U937 monocytic human cells. Our findings suggest that the current framework is fully capable of modelling cell dynamics in large arteries in a realistic and efficient manner.
Episodic Tremor and Slip (ETS) as a chaotic multiphysics spring
NASA Astrophysics Data System (ADS)
Veveakis, E.; Alevizos, S.; Poulet, T.
2017-03-01
Episodic Tremor and Slip (ETS) events display a rich behaviour of slow and accelerated slip with simple oscillatory to complicated chaotic time series. It is commonly believed that the fast events appearing as non volcanic tremors are signatures of deep fluid injection. The fluid source is suggested to be related to the breakdown of hydrous phyllosilicates, mainly the serpentinite group minerals such as antigorite or lizardite that are widespread in the top of the slab in subduction environments. Similar ETS sequences are recorded in different lithologies in exhumed crustal carbonate-rich thrusts where the fluid source is suggested to be the more vigorous carbonate decomposition reaction. If indeed both types of events can be understood and modelled by the same generic fluid release reaction AB(solid) ⇌A(solid) +B(fluid) , the data from ETS sequences in subduction zones reveal a geophysically tractable temporal evolution with no access to the fault zone. This work reviews recent advances in modelling ETS events considering the multiphysics instabilities triggered by the fluid release reaction and develops a thermal-hydraulic-mechanical-chemical oscillator (THMC spring) model for such mineral reactions (like dehydration and decomposition) in Megathrusts. We describe advanced computational methods for THMC instabilities and discuss spectral element and finite element solutions. We apply the presented numerical methods to field examples of this important mechanism and reproduce the temporal signature of the Cascadia and Hikurangi trench with a serpentinite oscillator.
NASA Astrophysics Data System (ADS)
Zhang, Jingyi
Ferroelectric (FE) and closely related antiferroelectric (AFE) materials have unique electromechanical properties that promote various applications in the area of capacitors, sensors, generators (FE) and high density energy storage (AFE). These smart materials with extensive applications have drawn wide interest in the industrial and scientific world because of their reliability and tunable property. However, reliability issues changes its paradigms and requires guidance from detailed mechanism theory as the materials applications are pushed for better performance. A host of modeling work were dedicated to study the macro-structural behavior and microstructural evolution in FE and AFE material under various conditions. This thesis is focused on direct observation of domain evolution under multiphysics loading for both FE and AFE material. Landau-Devonshire time-dependent phase field models were built for both materials, and were simulated in finite element software Comsol. In FE model, dagger-shape 90 degree switched domain was observed at preexisting crack tip under pure mechanical loading. Polycrystal structure was tested under same condition, and blocking effect of the growth of dagger-shape switched domain from grain orientation difference and/or grain boundary was directly observed. AFE ceramic model was developed using two sublattice theory, this model was used to investigate the mechanism of energy efficiency increase with self-confined loading in experimental tests. Consistent results was found in simulation and careful investigation of calculation results gave confirmation that origin of energy density increase is from three aspects: self-confinement induced inner compression field as the cause of increase of critical field, fringe leak as the source of elevated saturation polarization and uneven defects distribution as the reason for critical field shifting and phase transition speed. Another important affecting aspect in polycrystalline materials is the
DOE Office of Scientific and Technical Information (OSTI.GOV)
Yidong Xia; Mitch Plummer; Robert Podgorney
2016-02-01
Performance of heat production process over a 30-year period is assessed in a conceptual EGS model with a geothermal gradient of 65K per km depth in the reservoir. Water is circulated through a pair of parallel wells connected by a set of single large wing fractures. The results indicate that the desirable output electric power rate and lifespan could be obtained under suitable material properties and system parameters. A sensitivity analysis on some design constraints and operation parameters indicates that 1) the fracture horizontal spacing has profound effect on the long-term performance of heat production, 2) the downward deviation anglemore » for the parallel doublet wells may help overcome the difficulty of vertical drilling to reach a favorable production temperature, and 3) the thermal energy production rate and lifespan has close dependence on water mass flow rate. The results also indicate that the heat production can be improved when the horizontal fracture spacing, well deviation angle, and production flow rate are under reasonable conditions. To conduct the reservoir modeling and simulations, an open-source, finite element based, fully implicit, fully coupled hydrothermal code, namely FALCON, has been developed and used in this work. Compared with most other existing codes that are either closed-source or commercially available in this area, this new open-source code has demonstrated a code development strategy that aims to provide an unparalleled easiness for user-customization and multi-physics coupling. Test results have shown that the FALCON code is able to complete the long-term tests efficiently and accurately, thanks to the state-of-the-art nonlinear and linear solver algorithms implemented in the code.« less
Acceleration methods for multi-physics compressible flow
NASA Astrophysics Data System (ADS)
Peles, Oren; Turkel, Eli
2018-04-01
In this work we investigate the Runge-Kutta (RK)/Implicit smoother scheme as a convergence accelerator for complex multi-physics flow problems including turbulent, reactive and also two-phase flows. The flows considered are subsonic, transonic and supersonic flows in complex geometries, and also can be either steady or unsteady flows. All of these problems are considered to be a very stiff. We then introduce an acceleration method for the compressible Navier-Stokes equations. We start with the multigrid method for pure subsonic flow, including reactive flows. We then add the Rossow-Swanson-Turkel RK/Implicit smoother that enables performing all these complex flow simulations with a reasonable CFL number. We next discuss the RK/Implicit smoother for time dependent problem and also for low Mach numbers. The preconditioner includes an intrinsic low Mach number treatment inside the smoother operator. We also develop a modified Roe scheme with a corresponding flux Jacobian matrix. We then give the extension of the method for real gas and reactive flow. Reactive flows are governed by a system of inhomogeneous Navier-Stokes equations with very stiff source terms. The extension of the RK/Implicit smoother requires an approximation of the source term Jacobian. The properties of the Jacobian are very important for the stability of the method. We discuss what the chemical physics theory of chemical kinetics tells about the mathematical properties of the Jacobian matrix. We focus on the implication of the Le-Chatelier's principle on the sign of the diagonal entries of the Jacobian. We present the implementation of the method for turbulent flow. We use a two RANS turbulent model - one equation model - Spalart-Allmaras and a two-equation model - k-ω SST model. The last extension is for two-phase flows with a gas as a main phase and Eulerian representation of a dispersed particles phase (EDP). We present some examples for such flow computations inside a ballistic evaluation
Espino, Daniel M; Shepherd, Duncan E T; Hukins, David W L
2014-01-01
A transient multi-physics model of the mitral heart valve has been developed, which allows simultaneous calculation of fluid flow and structural deformation. A recently developed contact method has been applied to enable simulation of systole (the stage when blood pressure is elevated within the heart to pump blood to the body). The geometry was simplified to represent the mitral valve within the heart walls in two dimensions. Only the mitral valve undergoes deformation. A moving arbitrary Lagrange-Euler mesh is used to allow true fluid-structure interaction (FSI). The FSI model requires blood flow to induce valve closure by inducing strains in the region of 10-20%. Model predictions were found to be consistent with existing literature and will undergo further development.
NASA Astrophysics Data System (ADS)
Sevic, John F.; Kobayashi, Nobuhiko P.
2017-10-01
Self-assembled niobium dioxide (NbO2) thin-film selectors self-aligned to tantalum dioxide (TaO2) memristive memory cells are studied by a multi-physics transient solution of the heat equation coupled to the nonlinear current continuity equation. While a compact model can resolve the quasi-static bulk negative differential resistance (NDR), a self-consistent coupled transport formulation provides a non-equilibrium picture of NbO2-TaO2 selector-memristor operation ab initio. By employing the drift-diffusion transport approximation, a finite element method is used to study the dynamic electrothermal behavior of our experimentally obtained selector-memristor devices, showing that existing conditions are suitable for electroformation of NbO2 selector thin-films. Both transient and steady-state simulations support our theory, suggesting that the phase change due to insulator-metal transition is responsible for NbO2 selector NDR in our as-fabricated selector-memristor devices. Simulation results further suggest that TiN nano-via may play a central role in electroforming, as its dimensions and material properties establish the mutual electrothermal interaction between TiN nano-via and the selector-memristor.
Multi-Dimensional Simulation of LWR Fuel Behavior in the BISON Fuel Performance Code
NASA Astrophysics Data System (ADS)
Williamson, R. L.; Capps, N. A.; Liu, W.; Rashid, Y. R.; Wirth, B. D.
2016-11-01
Nuclear fuel operates in an extreme environment that induces complex multiphysics phenomena occurring over distances ranging from inter-atomic spacing to meters, and times scales ranging from microseconds to years. To simulate this behavior requires a wide variety of material models that are often complex and nonlinear. The recently developed BISON code represents a powerful fuel performance simulation tool based on its material and physical behavior capabilities, finite-element versatility of spatial representation, and use of parallel computing. The code can operate in full three dimensional (3D) mode, as well as in reduced two dimensional (2D) modes, e.g., axisymmetric radial-axial ( R- Z) or plane radial-circumferential ( R- θ), to suit the application and to allow treatment of global and local effects. A BISON case study was used to illustrate analysis of Pellet Clad Mechanical Interaction failures from manufacturing defects using combined 2D and 3D analyses. The analysis involved commercial fuel rods and demonstrated successful computation of metrics of interest to fuel failures, including cladding peak hoop stress and strain energy density. In comparison with a failure threshold derived from power ramp tests, results corroborate industry analyses of the root cause of the pellet-clad interaction failures and illustrate the importance of modeling 3D local effects around fuel pellet defects, which can produce complex effects including cold spots in the cladding, stress concentrations, and hot spots in the fuel that can lead to enhanced cladding degradation such as hydriding, oxidation, CRUD formation, and stress corrosion cracking.
Multi-Dimensional Simulation of LWR Fuel Behavior in the BISON Fuel Performance Code
Williamson, R. L.; Capps, N. A.; Liu, W.; ...
2016-09-27
Nuclear fuel operates in an extreme environment that induces complex multiphysics phenomena occurring over distances ranging from inter-atomic spacing to meters, and times scales ranging from microseconds to years. To simulate this behavior requires a wide variety of material models that are often complex and nonlinear. The recently developed BISON code represents a powerful fuel performance simulation tool based on its material and physical behavior capabilities, finite-element versatility of spatial representation, and use of parallel computing. The code can operate in full three dimensional (3D) mode, as well as in reduced two dimensional (2D) modes, e.g., axisymmetric radial-axial (R-Z) ormore » plane radial-circumferential (R-θ), to suit the application and to allow treatment of global and local effects. A BISON case study was used in this paper to illustrate analysis of Pellet Clad Mechanical Interaction failures from manufacturing defects using combined 2D and 3D analyses. The analysis involved commercial fuel rods and demonstrated successful computation of metrics of interest to fuel failures, including cladding peak hoop stress and strain energy density. Finally, in comparison with a failure threshold derived from power ramp tests, results corroborate industry analyses of the root cause of the pellet-clad interaction failures and illustrate the importance of modeling 3D local effects around fuel pellet defects, which can produce complex effects including cold spots in the cladding, stress concentrations, and hot spots in the fuel that can lead to enhanced cladding degradation such as hydriding, oxidation, CRUD formation, and stress corrosion cracking.« less
DOE Office of Scientific and Technical Information (OSTI.GOV)
Raskin, Cody; Owen, J. Michael, E-mail: raskin1@llnl.gov, E-mail: mikeowen@llnl.gov
2016-11-01
We discuss a generalization of the classic Keplerian disk test problem allowing for both pressure and rotational support, as a method of testing astrophysical codes incorporating both gravitation and hydrodynamics. We argue for the inclusion of pressure in rotating disk simulations on the grounds that realistic, astrophysical disks exhibit non-negligible pressure support. We then apply this test problem to examine the performance of various smoothed particle hydrodynamics (SPH) methods incorporating a number of improvements proposed over the years to address problems noted in modeling the classical gravitation-only Keplerian disk. We also apply this test to a newly developed extension ofmore » SPH based on reproducing kernels called CRKSPH. Counterintuitively, we find that pressure support worsens the performance of traditional SPH on this problem, causing unphysical collapse away from the steady-state disk solution even more rapidly than the purely gravitational problem, whereas CRKSPH greatly reduces this error.« less
Zheng, Nanfeng; Lu, Haiwei; Bu, Xianhui; Feng, Pingyun
2006-04-12
Chalcogenide II-VI nanoclusters are usually prepared as isolated clusters and have defied numerous efforts to join them into covalent open-framework architecture with conventional templating methods such as protonated amines or inorganic cations commonly used to direct the formation of porous frameworks. Herein, we report the first templated synthesis of II-VI covalent superlattices from large II-VI tetrahedral clusters (i.e., [Cd32S14(SPh)38]2-). Our method takes advantage of low charge density of metal-chelate dyes that is a unique match with three-dimensional II-VI semiconductor frameworks in charge density, surface hydrophilicity-hydrophobicity, and spatial organization. In addition, metal-chelate dyes also serve to tune the optical properties of resulting dye semiconductor composite materials.
Atomistic to Continuum Multiscale and Multiphysics Simulation of NiTi Shape Memory Alloy
NASA Astrophysics Data System (ADS)
Gur, Sourav
(transformation temperature, phase fraction evolution kinetics due to temperature) are also demonstrated herein. Next, to couple and transfer the statistical information of length scale dependent phase transformation process, multiscale/ multiphysics methods are used. Here, the computational difficulty from the fact that the representative governing equations (i.e. different sub-methods such as molecular dynamics simulations, phase field simulations and continuum level constitutive/ material models) are only valid or can be implemented over a range of spatiotemporal scales. Therefore, in the present study, a wavelet based multiscale coupling method is used, where simulation results (phase fraction evolution kinetics) from different sub-methods are linked via concurrent multiscale coupling fashion. Finally, these multiscale/ multiphysics simulation results are used to develop/ modify the macro/ continuum scale thermo-mechanical constitutive relations for NiTi SMA. Finally, the improved material model is used to model new devices, such as thermal diodes and smart dampers.
NASA Astrophysics Data System (ADS)
Bosch, R.; Ward, D.
2017-12-01
Investigation of erosion rates and processes at knickpoints in surface bedrock streams is an active area of research, involving complex feedbacks in the coupled relationships between dissolution, abrasion, and plucking that have not been sufficiently addressed. Even less research has addressed how these processes operate to propagate knickpoints through cave passages in layered sedimentary rocks, despite these features being common along subsurface streams. In both settings, there is evidence for mechanical and chemical erosion, but in cave passages the different hydrologic and hydraulic regimes, combined with an important role for the dissolution process, affect the relative roles and coupled interactions between these processes, and distinguish them from surface stream knickpoints. Using a novel approach of imaging cave passages using Structure from Motion (SFM), we create 3D geometry meshes to explore these systems using multiphysics simulation, and compare the processes as they occur in caves with those in surface streams. Here we focus on four field sites with actively eroding streambeds that include knickpoints: Upper River Acheron and Devil's Cooling Tub in Mammoth Cave, Kentucky; and two surface streams in Clermont County, Ohio, Avey's Run and Fox Run. SFM 3D reconstructions are built using images exported from 4K video shot at each field location. We demonstrate that SFM is a viable imaging approach for reconstructing cave passages with complex morphologies. We then use these reconstructions to create meshes upon which to run multiphysics simulations using STAR-CCM+. Our approach incorporates multiphase free-surface computational fluid dynamics simulations with sediment transport modeled using discrete element method grains. Physical and chemical properties of the water, bedrock, and sediment enable computation of shear stress, sediment impact forces, and chemical kinetic conditions at the bed surface. Preliminary results prove the efficacy of commercially
Smooth Particle Hydrodynamics GPU-Acceleration Tool for Asteroid Fragmentation Simulation
NASA Astrophysics Data System (ADS)
Buruchenko, Sergey K.; Schäfer, Christoph M.; Maindl, Thomas I.
2017-10-01
The impact threat of near-Earth objects (NEOs) is a concern to the global community, as evidenced by the Chelyabinsk event (caused by a 17-m meteorite) in Russia on February 15, 2013 and a near miss by asteroid 2012 DA14 ( 30 m diameter), on the same day. The expected energy, from either a low-altitude air burst or direct impact, would have severe consequences, especially in populated regions. To mitigate this threat one of the methods is employment of large kinetic-energy impactors (KEIs). The simulation of asteroid target fragmentation is a challenging task which demands efficient and accurate numerical methods with large computational power. Modern graphics processing units (GPUs) lead to a major increase 10 times and more in the performance of the computation of astrophysical and high velocity impacts. The paper presents a new implementation of the numerical method smooth particle hydrodynamics (SPH) using NVIDIA-GPU and the first astrophysical and high velocity application of the new code. The code allows for a tremendous increase in speed of astrophysical simulations with SPH and self-gravity at low costs for new hardware. We have implemented the SPH equations to model gas, liquids and elastic, and plastic solid bodies and added a fragmentation model for brittle materials. Self-gravity may be optionally included in the simulations.
Muley, Pranjali D; Boldor, Dorin
2012-01-01
Use of advanced microwave technology for biodiesel production from vegetable oil is a relatively new technology. Microwave dielectric heating increases the process efficiency and reduces reaction time. Microwave heating depends on various factors such as material properties (dielectric and thermo-physical), frequency of operation and system design. Although lab scale results are promising, it is important to study these parameters and optimize the process before scaling up. Numerical modeling approach can be applied for predicting heating and temperature profiles including at larger scale. The process can be studied for optimization without actually performing the experiments, reducing the amount of experimental work required. A basic numerical model of continuous electromagnetic heating of biodiesel precursors was developed. A finite element model was built using COMSOL Multiphysics 4.2 software by coupling the electromagnetic problem with the fluid flow and heat transfer problem. Chemical reaction was not taken into account. Material dielectric properties were obtained experimentally, while the thermal properties were obtained from the literature (all the properties were temperature dependent). The model was tested for the two different power levels 4000 W and 4700 W at a constant flow rate of 840ml/min. The electric field, electromagnetic power density flow and temperature profiles were studied. Resulting temperature profiles were validated by comparing to the temperatures obtained at specific locations from the experiment. The results obtained were in good agreement with the experimental data.
LLNL contributions to ANL Report ANL/NE-16/6 "Sharp User Manual"
DOE Office of Scientific and Technical Information (OSTI.GOV)
Solberg, J. M.
Diablo is a Multiphysics implicit finite element code with an emphasis on coupled structural/thermal analysis. In the SHARP framework, it is used as the structural solver, and may also be used as the mesh smoother.
Assessment of a hybrid finite element and finite volume code for turbulent incompressible flows
DOE Office of Scientific and Technical Information (OSTI.GOV)
Xia, Yidong, E-mail: yidong.xia@inl.gov; Wang, Chuanjin; Luo, Hong
Hydra-TH is a hybrid finite-element/finite-volume incompressible/low-Mach flow simulation code based on the Hydra multiphysics toolkit being developed and used for thermal-hydraulics applications. In the present work, a suite of verification and validation (V&V) test problems for Hydra-TH was defined to meet the design requirements of the Consortium for Advanced Simulation of Light Water Reactors (CASL). The intent for this test problem suite is to provide baseline comparison data that demonstrates the performance of the Hydra-TH solution methods. The simulation problems vary in complexity from laminar to turbulent flows. A set of RANS and LES turbulence models were used in themore » simulation of four classical test problems. Numerical results obtained by Hydra-TH agreed well with either the available analytical solution or experimental data, indicating the verified and validated implementation of these turbulence models in Hydra-TH. Where possible, some form of solution verification has been attempted to identify sensitivities in the solution methods, and suggest best practices when using the Hydra-TH code. -- Highlights: •We performed a comprehensive study to verify and validate the turbulence models in Hydra-TH. •Hydra-TH delivers 2nd-order grid convergence for the incompressible Navier–Stokes equations. •Hydra-TH can accurately simulate the laminar boundary layers. •Hydra-TH can accurately simulate the turbulent boundary layers with RANS turbulence models. •Hydra-TH delivers high-fidelity LES capability for simulating turbulent flows in confined space.« less
Generating code adapted for interlinking legacy scalar code and extended vector code
Gschwind, Michael K
2013-06-04
Mechanisms for intermixing code are provided. Source code is received for compilation using an extended Application Binary Interface (ABI) that extends a legacy ABI and uses a different register configuration than the legacy ABI. First compiled code is generated based on the source code, the first compiled code comprising code for accommodating the difference in register configurations used by the extended ABI and the legacy ABI. The first compiled code and second compiled code are intermixed to generate intermixed code, the second compiled code being compiled code that uses the legacy ABI. The intermixed code comprises at least one call instruction that is one of a call from the first compiled code to the second compiled code or a call from the second compiled code to the first compiled code. The code for accommodating the difference in register configurations is associated with the at least one call instruction.
COMSOL Multiphysics Model for HLW Canister Filling
DOE Office of Scientific and Technical Information (OSTI.GOV)
Kesterson, M. R.
2016-04-11
The U.S. Department of Energy (DOE) is building a Tank Waste Treatment and Immobilization Plant (WTP) at the Hanford Site in Washington to remediate 55 million gallons of radioactive waste that is being temporarily stored in 177 underground tanks. Efforts are being made to increase the loading of Hanford tank wastes in glass while meeting melter lifetime expectancies and process, regulatory, and product quality requirements. Wastes containing high concentrations of Al 2O 3 and Na 2O can contribute to nepheline (generally NaAlSiO 4) crystallization, which can sharply reduce the chemical durability of high level waste (HLW) glass. Nepheline crystallization canmore » occur during slow cooling of the glass within the stainless steel canister. The purpose of this work was to develop a model that can be used to predict temperatures of the glass in a WTP HLW canister during filling and cooling. The intent of the model is to support scoping work in the laboratory. It is not intended to provide precise predictions of temperature profiles, but rather to provide a simplified representation of glass cooling profiles within a full scale, WTP HLW canister under various glass pouring rates. These data will be used to support laboratory studies for an improved understanding of the mechanisms of nepheline crystallization. The model was created using COMSOL Multiphysics, a commercially available software. The model results were compared to available experimental data, TRR-PLT-080, and were found to yield sufficient results for the scoping nature of the study. The simulated temperatures were within 60 ºC for the centerline, 0.0762m (3 inch) from centerline, and 0.2286m (9 inch) from centerline thermocouples once the thermocouples were covered with glass. The temperature difference between the experimental and simulated values reduced to 40 ºC, 4 hours after the thermocouple was covered, and down to 20 ºC, 6 hours after the thermocouple was covered. This level of precision is
A multiphysics and multiscale model for low frequency electromagnetic direct-chill casting
NASA Astrophysics Data System (ADS)
Košnik, N.; Guštin, A. Z.; Mavrič, B.; Šarler, B.
2016-03-01
Simulation and control of macrosegregation, deformation and grain size in low frequency electromagnetic (EM) direct-chill casting (LFEMC) is important for downstream processing. Respectively, a multiphysics and multiscale model is developed for solution of Lorentz force, temperature, velocity, concentration, deformation and grain structure of LFEMC processed aluminum alloys, with focus on axisymmetric billets. The mixture equations with lever rule, linearized phase diagram, and stationary thermoelastic solid phase are assumed, together with EM induction equation for the field imposed by the coil. Explicit diffuse approximate meshless solution procedure [1] is used for solving the EM field, and the explicit local radial basis function collocation method [2] is used for solving the coupled transport phenomena and thermomechanics fields. Pressure-velocity coupling is performed by the fractional step method [3]. The point automata method with modified KGT model is used to estimate the grain structure [4] in a post-processing mode. Thermal, mechanical, EM and grain structure outcomes of the model are demonstrated. A systematic study of the complicated influences of the process parameters can be investigated by the model, including intensity and frequency of the electromagnetic field. The meshless solution framework, with the implemented simplest physical models, will be further extended by including more sophisticated microsegregation and grain structure models, as well as a more realistic solid and solid-liquid phase rheology.
Interfacial mixing in high-energy-density matter with a multiphysics kinetic model
NASA Astrophysics Data System (ADS)
Haack, Jeffrey R.; Hauck, Cory D.; Murillo, Michael S.
2017-12-01
We have extended a recently developed multispecies, multitemperature Bhatnagar-Gross-Krook model [Haack et al., J. Stat. Phys. 168, 822 (2017), 10.1007/s10955-017-1824-9], to include multiphysics capabilities that enable modeling of a wider range of physical conditions. In terms of geometry, we have extended from the spatially homogeneous setting to one spatial dimension. In terms of the physics, we have included an atomic ionization model, accurate collision physics across coupling regimes, self-consistent electric fields, and degeneracy in the electronic screening. We apply the model to a warm dense matter scenario in which the ablator-fuel interface of an inertial confinement fusion target is heated, but for larger length and time scales and for much higher temperatures than can be simulated using molecular dynamics. Relative to molecular dynamics, the kinetic model greatly extends the temperature regime and the spatiotemporal scales over which we are able to model. In our numerical results we observe hydrogen from the ablator material jetting into the fuel during the early stages of the implosion and compare the relative size of various diffusion components (Fickean diffusion, electrodiffusion, and barodiffusion) that drive this process. We also examine kinetic effects, such as anisotropic distributions and velocity separation, in order to determine when this problem can be described with a hydrodynamic model.
Experimental multiphysical characterization of an SMA driven, camber morphing owl wing section
NASA Astrophysics Data System (ADS)
Stroud, Hannah R.; Leal, Pedro B. C.; Hartl, Darren J.
2018-03-01
In the context of aerospace engineering, morphing structures are useful in their ability to change the outer mold line (OML) while improving or maintaining certain aerodynamic performance metrics. Skin-based morphing is of particular interest in that it minimizes installation volume. Shape memory alloys (SMAs) have a high force to volume ratio that makes them a suitable choice for skin-based morphing. Because the thermomechanical properties of SMAs are coupled, strain can be generated via a temperature variation; this phenomenon is used as the actuation method. Therefore, it is necessary to determine the interaction of the system not only with aerodynamic loads, but with thermal loads as well. This paper describes the wind tunnel testing and in situ thermomechanical analysis of an SMA actuated, avian inspired morphing wing. The morphing wing is embedded with two SMA composite actuators and consists of a foam core enveloped in a fiberglass-epoxy composite. As the SMA wire is heated, the actuator contracts, morphing the wing from the original owl OML to a highly cambered, high lift OML. Configuration characteristics are analyzed in situ using simultaneous three dimensional digital image correlation (DIC) and infrared thermography, thereby coupling strain and thermal measurements. This method of testing allows for the nonintrusive, multiphysical data acquisition of each actuator separately and the system as a whole.
Fovargue, Daniel E; Mitran, Sorin; Smith, Nathan B; Sankin, Georgy N; Simmons, Walter N; Zhong, Pei
2013-08-01
A multiphysics computational model of the focusing of an acoustic pulse and subsequent shock wave formation that occurs during extracorporeal shock wave lithotripsy is presented. In the electromagnetic lithotripter modeled in this work the focusing is achieved via a polystyrene acoustic lens. The transition of the acoustic pulse through the solid lens is modeled by the linear elasticity equations and the subsequent shock wave formation in water is modeled by the Euler equations with a Tait equation of state. Both sets of equations are solved simultaneously in subsets of a single computational domain within the BEARCLAW framework which uses a finite-volume Riemann solver approach. This model is first validated against experimental measurements with a standard (or original) lens design. The model is then used to successfully predict the effects of a lens modification in the form of an annular ring cut. A second model which includes a kidney stone simulant in the domain is also presented. Within the stone the linear elasticity equations incorporate a simple damage model.
Fovargue, Daniel E.; Mitran, Sorin; Smith, Nathan B.; Sankin, Georgy N.; Simmons, Walter N.; Zhong, Pei
2013-01-01
A multiphysics computational model of the focusing of an acoustic pulse and subsequent shock wave formation that occurs during extracorporeal shock wave lithotripsy is presented. In the electromagnetic lithotripter modeled in this work the focusing is achieved via a polystyrene acoustic lens. The transition of the acoustic pulse through the solid lens is modeled by the linear elasticity equations and the subsequent shock wave formation in water is modeled by the Euler equations with a Tait equation of state. Both sets of equations are solved simultaneously in subsets of a single computational domain within the BEARCLAW framework which uses a finite-volume Riemann solver approach. This model is first validated against experimental measurements with a standard (or original) lens design. The model is then used to successfully predict the effects of a lens modification in the form of an annular ring cut. A second model which includes a kidney stone simulant in the domain is also presented. Within the stone the linear elasticity equations incorporate a simple damage model. PMID:23927200
Blast Fragmentation Modeling and Analysis
2010-10-31
weapons device containing a multiphase blast explosive (MBX). 1. INTRODUCTION The ARL Survivability Lethality and Analysis Directorate (SLAD) is...velocity. In order to simulate the highly complex phenomenon, the exploding cylinder is modeled with the hydrodynamics code ALE3D , an arbitrary...Lagrangian-Eulerian multiphysics code, developed at Lawrence Livermore National Laboratory. ALE3D includes physical properties, constitutive models for
A novel medical image data-based multi-physics simulation platform for computational life sciences.
Neufeld, Esra; Szczerba, Dominik; Chavannes, Nicolas; Kuster, Niels
2013-04-06
Simulating and modelling complex biological systems in computational life sciences requires specialized software tools that can perform medical image data-based modelling, jointly visualize the data and computational results, and handle large, complex, realistic and often noisy anatomical models. The required novel solvers must provide the power to model the physics, biology and physiology of living tissue within the full complexity of the human anatomy (e.g. neuronal activity, perfusion and ultrasound propagation). A multi-physics simulation platform satisfying these requirements has been developed for applications including device development and optimization, safety assessment, basic research, and treatment planning. This simulation platform consists of detailed, parametrized anatomical models, a segmentation and meshing tool, a wide range of solvers and optimizers, a framework for the rapid development of specialized and parallelized finite element method solvers, a visualization toolkit-based visualization engine, a Python scripting interface for customized applications, a coupling framework, and more. Core components are cross-platform compatible and use open formats. Several examples of applications are presented: hyperthermia cancer treatment planning, tumour growth modelling, evaluating the magneto-haemodynamic effect as a biomarker and physics-based morphing of anatomical models.
NASA Astrophysics Data System (ADS)
Ahmad, A. A.; Alsaad, A.; Al-Bataineh, Q. M.; Al-Naafa, M. A.
2018-02-01
In this study, Lithium niobate (LiNbO3) and Aluminum nitride (AlN) nanostructures were designed and investigated using the COMSOL Multiphysics software for pressure sensing applications. The Finite Element Method (FEM) was used for solving the differential equations with various parameters such as size, length, force, etc. The variation of the total maximum displacement as a function of applied force for various NWs lengths and the variation of the voltage as a function of applied force were plotted and discussed. AlN nanowires exhibit a better piezoelectric response than LiNbO3 nanowires do.
nIFTY galaxy cluster simulations - III. The similarity and diversity of galaxies and subhaloes
NASA Astrophysics Data System (ADS)
Elahi, Pascal J.; Knebe, Alexander; Pearce, Frazer R.; Power, Chris; Yepes, Gustavo; Cui, Weiguang; Cunnama, Daniel; Kay, Scott T.; Sembolini, Federico; Beck, Alexander M.; Davé, Romeel; February, Sean; Huang, Shuiyao; Katz, Neal; McCarthy, Ian G.; Murante, Giuseppe; Perret, Valentin; Puchwein, Ewald; Saro, Alexandro; Teyssier, Romain
2016-05-01
We examine subhaloes and galaxies residing in a simulated Λ cold dark matter galaxy cluster (M^crit_{200}=1.1× 10^{15} h^{-1} M_{⊙}) produced by hydrodynamical codes ranging from classic smooth particle hydrodynamics (SPH), newer SPH codes, adaptive and moving mesh codes. These codes use subgrid models to capture galaxy formation physics. We compare how well these codes reproduce the same subhaloes/galaxies in gravity-only, non-radiative hydrodynamics and full feedback physics runs by looking at the overall subhalo/galaxy distribution and on an individual object basis. We find that the subhalo population is reproduced to within ≲10 per cent for both dark matter only and non-radiative runs, with individual objects showing code-to-code scatter of ≲0.1 dex, although the gas in non-radiative simulations shows significant scatter. Including feedback physics significantly increases the diversity. Subhalo mass and Vmax distributions vary by ≈20 per cent. The galaxy populations also show striking code-to-code variations. Although the Tully-Fisher relation is similar in almost all codes, the number of galaxies with 109 h- 1 M⊙ ≲ M* ≲ 1012 h- 1 M⊙ can differ by a factor of 4. Individual galaxies show code-to-code scatter of ˜0.5 dex in stellar mass. Moreover, systematic differences exist, with some codes producing galaxies 70 per cent smaller than others. The diversity partially arises from the inclusion/absence of active galactic nucleus feedback. Our results combined with our companion papers demonstrate that subgrid physics is not just subject to fine-tuning, but the complexity of building galaxies in all environments remains a challenge. We argue that even basic galaxy properties, such as stellar mass to halo mass, should be treated with errors bars of ˜0.2-0.4 dex.
Multiphysics modeling of two-phase film boiling within porous corrosion deposits
DOE Office of Scientific and Technical Information (OSTI.GOV)
Jin, Miaomiao, E-mail: mmjin@mit.edu; Short, Michael, E-mail: hereiam@mit.edu
2016-07-01
Porous corrosion deposits on nuclear fuel cladding, known as CRUD, can cause multiple operational problems in light water reactors (LWRs). CRUD can cause accelerated corrosion of the fuel cladding, increase radiation fields and hence greater exposure risk to plant workers once activated, and induce a downward axial power shift causing an imbalance in core power distribution. In order to facilitate a better understanding of CRUD's effects, such as localized high cladding surface temperatures related to accelerated corrosion rates, we describe an improved, fully-coupled, multiphysics model to simulate heat transfer, chemical reactions and transport, and two-phase fluid flow within these deposits.more » Our new model features a reformed assumption of 2D, two-phase film boiling within the CRUD, correcting earlier models' assumptions of single-phase coolant flow with wick boiling under high heat fluxes. This model helps to better explain observed experimental values of the effective CRUD thermal conductivity. Finally, we propose a more complete set of boiling regimes, or a more detailed mechanism, to explain recent CRUD deposition experiments by suggesting the new concept of double dryout specifically in thick porous media with boiling chimneys. - Highlights: • A two-phase model of CRUD's effects on fuel cladding is developed and improved. • This model eliminates the formerly erroneous assumption of wick boiling. • Higher fuel cladding temperatures are predicted when accounting for two-phase flow. • Double-peaks in thermal conductivity vs. heat flux in experiments are explained. • A “double dryout” mechanism in CRUD is proposed based on the model and experiments.« less
A self-taught artificial agent for multi-physics computational model personalization.
Neumann, Dominik; Mansi, Tommaso; Itu, Lucian; Georgescu, Bogdan; Kayvanpour, Elham; Sedaghat-Hamedani, Farbod; Amr, Ali; Haas, Jan; Katus, Hugo; Meder, Benjamin; Steidl, Stefan; Hornegger, Joachim; Comaniciu, Dorin
2016-12-01
Personalization is the process of fitting a model to patient data, a critical step towards application of multi-physics computational models in clinical practice. Designing robust personalization algorithms is often a tedious, time-consuming, model- and data-specific process. We propose to use artificial intelligence concepts to learn this task, inspired by how human experts manually perform it. The problem is reformulated in terms of reinforcement learning. In an off-line phase, Vito, our self-taught artificial agent, learns a representative decision process model through exploration of the computational model: it learns how the model behaves under change of parameters. The agent then automatically learns an optimal strategy for on-line personalization. The algorithm is model-independent; applying it to a new model requires only adjusting few hyper-parameters of the agent and defining the observations to match. The full knowledge of the model itself is not required. Vito was tested in a synthetic scenario, showing that it could learn how to optimize cost functions generically. Then Vito was applied to the inverse problem of cardiac electrophysiology and the personalization of a whole-body circulation model. The obtained results suggested that Vito could achieve equivalent, if not better goodness of fit than standard methods, while being more robust (up to 11% higher success rates) and with faster (up to seven times) convergence rate. Our artificial intelligence approach could thus make personalization algorithms generalizable and self-adaptable to any patient and any model. Copyright © 2016. Published by Elsevier B.V.
Moving-mesh cosmology: characteristics of galaxies and haloes
NASA Astrophysics Data System (ADS)
Kereš, Dušan; Vogelsberger, Mark; Sijacki, Debora; Springel, Volker; Hernquist, Lars
2012-09-01
We discuss cosmological hydrodynamic simulations of galaxy formation performed with the new moving-mesh code AREPO, which promises higher accuracy compared with the traditional smoothed particle hydrodynamics (SPH) technique that has been widely employed for this problem. In this exploratory study, we deliberately limit the complexity of the physical processes followed by the code for ease of comparison with previous calculations, and include only cooling of gas with a primordial composition, heating by a spatially uniform ultraviolet background, and a simple subresolution model for regulating star formation in the dense interstellar medium. We use an identical set of physics in corresponding simulations carried out with the well-tested SPH code GADGET, adopting also the same high-resolution gravity solver. We are thus able to compare both simulation sets on an object-by-object basis, allowing us to cleanly isolate the impact of different hydrodynamical methods on galaxy and halo properties. In accompanying papers, Vogelsberger et al. and Sijacki et al., we focus on an analysis of the global baryonic statistics predicted by the simulation codes, and complementary idealized simulations that highlight the differences between the hydrodynamical schemes. Here we investigate their influence on the baryonic properties of simulated galaxies and their surrounding haloes. We find that AREPO leads to significantly higher star formation rates for galaxies in massive haloes and to more extended gaseous discs in galaxies, which also feature a thinner and smoother morphology than their GADGET counterparts. Consequently, galaxies formed in AREPO have larger sizes and higher specific angular momentum than their SPH correspondents. Interestingly, the more efficient cooling flows in AREPO yield higher densities and lower entropies in halo centres compared to GADGET, whereas the opposite trend is found in halo outskirts. The cooling differences leading to higher star formation rates
TerraFERMA: Harnessing Advanced Computational Libraries in Earth Science
NASA Astrophysics Data System (ADS)
Wilson, C. R.; Spiegelman, M.; van Keken, P.
2012-12-01
Many important problems in Earth sciences can be described by non-linear coupled systems of partial differential equations. These "multi-physics" problems include thermo-chemical convection in Earth and planetary interiors, interactions of fluids and magmas with the Earth's mantle and crust and coupled flow of water and ice. These problems are of interest to a large community of researchers but are complicated to model and understand. Much of this complexity stems from the nature of multi-physics where small changes in the coupling between variables or constitutive relations can lead to radical changes in behavior, which in turn affect critical computational choices such as discretizations, solvers and preconditioners. To make progress in understanding such coupled systems requires a computational framework where multi-physics problems can be described at a high-level while maintaining the flexibility to easily modify the solution algorithm. Fortunately, recent advances in computational science provide a basis for implementing such a framework. Here we present the Transparent Finite Element Rapid Model Assembler (TerraFERMA), which leverages several advanced open-source libraries for core functionality. FEniCS (fenicsproject.org) provides a high level language for describing the weak forms of coupled systems of equations, and an automatic code generator that produces finite element assembly code. PETSc (www.mcs.anl.gov/petsc) provides a wide range of scalable linear and non-linear solvers that can be composed into effective multi-physics preconditioners. SPuD (amcg.ese.ic.ac.uk/Spud) is an application neutral options system that provides both human and machine-readable interfaces based on a single xml schema. Our software integrates these libraries and provides the user with a framework for exploring multi-physics problems. A single options file fully describes the problem, including all equations, coefficients and solver options. Custom compiled applications are
SPH calculations of asteroid disruptions: The role of pressure dependent failure models
NASA Astrophysics Data System (ADS)
Jutzi, Martin
2015-03-01
We present recent improvements of the modeling of the disruption of strength dominated bodies using the Smooth Particle Hydrodynamics (SPH) technique. The improvements include an updated strength model and a friction model, which are successfully tested by a comparison with laboratory experiments. In the modeling of catastrophic disruptions of asteroids, a comparison between old and new strength models shows no significant deviation in the case of targets which are initially non-porous, fully intact and have a homogeneous structure (such as the targets used in the study by Benz and Asphaug, 1999). However, for many cases (e.g. initially partly or fully damaged targets and rubble-pile structures) we find that it is crucial that friction is taken into account and the material has a pressure dependent shear strength. Our investigations of the catastrophic disruption threshold 
NASA Astrophysics Data System (ADS)
Spiegelman, M. W.; Wilson, C. R.; Van Keken, P. E.
2013-12-01
We announce the release of a new software infrastructure, TerraFERMA, the Transparent Finite Element Rapid Model Assembler for the exploration and solution of coupled multi-physics problems. The design of TerraFERMA is driven by two overarching computational needs in Earth sciences. The first is the need for increased flexibility in both problem description and solution strategies for coupled problems where small changes in model assumptions can often lead to dramatic changes in physical behavior. The second is the need for software and models that are more transparent so that results can be verified, reproduced and modified in a manner such that the best ideas in computation and earth science can be more easily shared and reused. TerraFERMA leverages three advanced open-source libraries for scientific computation that provide high level problem description (FEniCS), composable solvers for coupled multi-physics problems (PETSc) and a science neutral options handling system (SPuD) that allows the hierarchical management of all model options. TerraFERMA integrates these libraries into an easier to use interface that organizes the scientific and computational choices required in a model into a single options file, from which a custom compiled application is generated and run. Because all models share the same infrastructure, models become more reusable and reproducible. TerraFERMA inherits much of its functionality from the underlying libraries. It currently solves partial differential equations (PDE) using finite element methods on simplicial meshes of triangles (2D) and tetrahedra (3D). The software is particularly well suited for non-linear problems with complex coupling between components. We demonstrate the design and utility of TerraFERMA through examples of thermal convection and magma dynamics. TerraFERMA has been tested successfully against over 45 benchmark problems from 7 publications in incompressible and compressible convection, magmatic solitary waves
A tightly-coupled domain-decomposition approach for highly nonlinear stochastic multiphysics systems
DOE Office of Scientific and Technical Information (OSTI.GOV)
Taverniers, Søren; Tartakovsky, Daniel M., E-mail: dmt@ucsd.edu
2017-02-01
Multiphysics simulations often involve nonlinear components that are driven by internally generated or externally imposed random fluctuations. When used with a domain-decomposition (DD) algorithm, such components have to be coupled in a way that both accurately propagates the noise between the subdomains and lends itself to a stable and cost-effective temporal integration. We develop a conservative DD approach in which tight coupling is obtained by using a Jacobian-free Newton–Krylov (JfNK) method with a generalized minimum residual iterative linear solver. This strategy is tested on a coupled nonlinear diffusion system forced by a truncated Gaussian noise at the boundary. Enforcement ofmore » path-wise continuity of the state variable and its flux, as opposed to continuity in the mean, at interfaces between subdomains enables the DD algorithm to correctly propagate boundary fluctuations throughout the computational domain. Reliance on a single Newton iteration (explicit coupling), rather than on the fully converged JfNK (implicit) coupling, may increase the solution error by an order of magnitude. Increase in communication frequency between the DD components reduces the explicit coupling's error, but makes it less efficient than the implicit coupling at comparable error levels for all noise strengths considered. Finally, the DD algorithm with the implicit JfNK coupling resolves temporally-correlated fluctuations of the boundary noise when the correlation time of the latter exceeds some multiple of an appropriately defined characteristic diffusion time.« less
NASA Astrophysics Data System (ADS)
Hagmeyer, Britta; Schütte, Julia; Böttger, Jan; Gebhardt, Rolf; Stelzle, Martin
2013-03-01
Replacing animal testing with in vitro cocultures of human cells is a long-term goal in pre-clinical drug tests used to gain reliable insight into drug-induced cell toxicity. However, current state-of-the-art 2D or 3D cell cultures aiming at mimicking human organs in vitro still lack organ-like morphology and perfusion and thus organ-like functions. To this end, microfluidic systems enable construction of cell culture devices which can be designed to more closely resemble the smallest functional unit of organs. Multiphysics simulations represent a powerful tool to study the various relevant physical phenomena and their impact on functionality inside microfluidic structures. This is particularly useful as it allows for assessment of system functions already during the design stage prior to actual chip fabrication. In the HepaChip®, dielectrophoretic forces are used to assemble human hepatocytes and human endothelial cells in liver sinusoid-like structures. Numerical simulations of flow distribution, shear stress, electrical fields and heat dissipation inside the cell assembly chambers as well as surface wetting and surface tension effects during filling of the microchannel network supported the design of this human-liver-on-chip microfluidic system for cell culture applications. Based on the device design resulting thereof, a prototype chip was injection-moulded in COP (cyclic olefin polymer). Functional hepatocyte and endothelial cell cocultures were established inside the HepaChip® showing excellent metabolic and secretory performance.
NASA Astrophysics Data System (ADS)
Liu, Meng; Liu, Yuan; Hui, Min; Song, Chengwen; Cui, Zhaoxia
2017-03-01
Clip domain serine proteases (cSPs) and their homologs (SPHs) play an important role in various biological processes that are essential components of extracellular signaling cascades, especially in the innate immune responses of invertebrates. Here, polymorphisms of PtcSP and PtSPH from the swimming crab Portunus trituberculatus were investigated to explore their association with resistance/susceptibility to Vibrio alginolyticus. Polymorphic loci were identified using Clustal X, and characterized with SPSS 16.0 software, and then the significance of genotype and allele frequencies between resistant and susceptible stocks was determined by a χ 2 test. A total of 109 and 77 single nucleotide polymorphisms (SNPs) were identified in the genomic fragments of PtcSP and PtSPH, respectively. Notably, nearly half of PtSPH polymorphisms were found in the non-coding exon 1. Fourteen SNPs investigated were significantly associated with susceptibility/resistance to V. alginolyticus ( P <0.05). Among them, eight SNPs were observed in introns, and one synonymous, four non-synonymous SNPs and one ins-del were found in coding exons. In addition, five simple sequence repeats (SSRs) were detected in intron 3 of PtcSP. Although there was no statistically significant difference of allele frequencies, the SSRs showed different polymorphic alleles on the basis of the repeat number between resistant and susceptible stocks. After further validation, polymorphisms investigated here might be applied to select potential molecular markers of P. trituberculatus with resistance to V. alginolyticus.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Jonkman, Jason; Annoni, Jennifer; Hayman, Greg
2017-01-01
This paper presents the development of FAST.Farm, a new multiphysics tool applicable to engineering problems in research and industry involving wind farm performance and cost optimization that is needed to address the current underperformance, failures, and expenses plaguing the wind industry. Achieving wind cost-of-energy targets - which requires improvements in wind farm performance and reliability, together with reduced uncertainty and expenditures - has been eluded by the complicated nature of the wind farm design problem, especially the sophisticated interaction between atmospheric phenomena and wake dynamics and array effects. FAST.Farm aims to balance the need for accurate modeling of the relevantmore » physics for predicting power performance and loads while maintaining low computational cost to support a highly iterative and probabilistic design process and system-wide optimization. FAST.Farm makes use of FAST to model the aero-hydro-servo-elastics of distinct turbines in the wind farm, and it is based on some of the principles of the Dynamic Wake Meandering (DWM) model, but avoids many of the limitations of existing DWM implementations.« less
DOE Office of Scientific and Technical Information (OSTI.GOV)
Yu, Y. Q.; Shemon, E. R.; Mahadevan, Vijay S.
SHARP, developed under the NEAMS Reactor Product Line, is an advanced modeling and simulation toolkit for the analysis of advanced nuclear reactors. SHARP is comprised of three physics modules currently including neutronics, thermal hydraulics, and structural mechanics. SHARP empowers designers to produce accurate results for modeling physical phenomena that have been identified as important for nuclear reactor analysis. SHARP can use existing physics codes and take advantage of existing infrastructure capabilities in the MOAB framework and the coupling driver/solver library, the Coupled Physics Environment (CouPE), which utilizes the widely used, scalable PETSc library. This report aims at identifying the coupled-physicsmore » simulation capability of SHARP by introducing the demonstration example called sahex in advance of the SHARP release expected by Mar 2016. sahex consists of 6 fuel pins with cladding, 1 control rod, sodium coolant and an outer duct wall that encloses all the other components. This example is carefully chosen to demonstrate the proof of concept for solving more complex demonstration examples such as EBR II assembly and ABTR full core. The workflow of preparing the input files, running the case and analyzing the results is demonstrated in this report. Moreover, an extension of the sahex model called sahex_core, which adds six homogenized neighboring assemblies to the full heterogeneous sahex model, is presented to test homogenization capabilities in both Nek5000 and PROTEUS. Some primary information on the configuration and build aspects for the SHARP toolkit, which includes capability to auto-download dependencies and configure/install with optimal flags in an architecture-aware fashion, is also covered by this report. A step-by-step instruction is provided to help users to create their cases. Details on these processes will be provided in the SHARP user manual that will accompany the first release.« less
A liquid metal-based structurally embedded vascular antenna: I. Concept and multiphysical modeling
NASA Astrophysics Data System (ADS)
Hartl, D. J.; Frank, G. J.; Huff, G. H.; Baur, J. W.
2017-02-01
This work proposes a new concept for a reconfigurable structurally embedded vascular antenna (SEVA). The work builds on ongoing research of structurally embedded microvascular systems in laminated structures for thermal transport and self-healing and on studies of non-toxic liquid metals for reconfigurable electronics. In the example design, liquid metal-filled channels in a laminated composite act as radiating elements for a high-power planar zig-zag wire log periodic dipole antenna. Flow of liquid metal through the channels is used to limit the temperature of the composite in which the antenna is embedded. A multiphysics engineering model of the transmitting antenna is formulated that couples the electromagnetic, fluid, thermal, and mechanical responses. In part 1 of this two-part work, it is shown that the liquid metal antenna is highly reconfigurable in terms of its electromagnetic response and that dissipated thermal energy generated during high power operation can be offset by the action of circulating or cyclically replacing the liquid metal such that heat is continuously removed from the system. In fact, the SEVA can potentially outperform traditional copper-based antennas in high-power operational configurations. The coupled engineering model is implemented in an automated framework and a design of experiment study is performed to quantify first-order design trade-offs in this multifunctional structure. More rigorous design optimization is addressed in part 2.
NASA Astrophysics Data System (ADS)
Li, Hua; Wang, Xiaogui; Yan, Guoping; Lam, K. Y.; Cheng, Sixue; Zou, Tao; Zhuo, Renxi
2005-03-01
In this paper, a novel multiphysic mathematical model is developed for simulation of swelling equilibrium of ionized temperature sensitive hydrogels with the volume phase transition, and it is termed the multi-effect-coupling thermal-stimulus (MECtherm) model. This model consists of the steady-state Nernst-Planck equation, Poisson equation and swelling equilibrium governing equation based on the Flory's mean field theory, in which two types of polymer-solvent interaction parameters, as the functions of temperature and polymer-network volume fraction, are specified with or without consideration of the hydrogen bond interaction. In order to examine the MECtherm model consisting of nonlinear partial differential equations, a meshless Hermite-Cloud method is used for numerical solution of one-dimensional swelling equilibrium of thermal-stimulus responsive hydrogels immersed in a bathing solution. The computed results are in very good agreements with experimental data for the variation of volume swelling ratio with temperature. The influences of the salt concentration and initial fixed-charge density are discussed in detail on the variations of volume swelling ratio of hydrogels, mobile ion concentrations and electric potential of both interior hydrogels and exterior bathing solution.
NASA Astrophysics Data System (ADS)
Saitou, Y.
2018-01-01
An SPH (Smoothed Particle Hydrodynamics) simulation code is developed to reproduce our findings on behavior of dust particles, which were obtained in our previous experiments (Phys. Plasmas, 23, 013709 (2016) and Abst. 18th Intern. Cong. Plasma Phys. (Kaohsiung, 2016)). Usually, in an SPH simulation, a smoothed particle is interpreted as a discretized fluid element. Here we regard the particles as dust particles because it is known that behavior of dust particles in complex plasmas can be described using fluid dynamics equations in many cases. Various rotation velocities that are difficult to achieve in the experiment are given to particles at boundaries in the newly developed simulation and motion of particles is investigated. Preliminary results obtained by the simulation are shown.
NASA Astrophysics Data System (ADS)
Michel, Y.; Chevalier, J.-M.; Durin, C.; Espinosa, C.; Malaise, F.; Barrau, J.-J.
2006-08-01
The purpose of this study is to present a new material model adapted to SPH modelling of dynamic behaviour of glasses under shock loadings. This model has the ability to reproduce fragmentation and densification of glasses under compression as well as brittle tensile failure. It has been implemented in Ls-Dyna software and coupled with a SPH code. By comparison with CEA-CESTA experimental data the model has been validated for fused silica and Pyrex glass for stress level up to 35GPa. For Laser MegaJoule applications, the present material model was applied to 3D high velocity impacts on thin brittle targets with good agreement with experimental data obtained using CESTA's double stage light gas gun in term of damages and matter ejection.
Safe patient handling perceptions and practices: a survey of acute care physical therapists.
Olkowski, Brian F; Stolfi, Angela M
2014-05-01
Acute care physical therapists are at risk for developing work-related musculoskeletal disorders (WMSDs) due to manual patient handling. Safe patient handling (SPH) reduces WMSDs caused by manual handling. The purpose of this study was to describe the patient handling practices of acute care physical therapists and their perceptions regarding SPH. Additionally, this study determined whether an SPH program influences the patient handling practices and perceptions regarding SPH of acute care physical therapists. Subscribers to the electronic discussion board of American Physical Therapy Association's Acute Care Section were invited to complete a survey questionnaire. The majority of respondents used SPH equipment and practices (91.1%), were confident using SPH equipment and practices (93.8%), agreed that evidence supports the use of SPH equipment and practices (87.0%), and reported the use of SPH equipment and practices is feasible (92.2%). Respondents at a facility with an SPH program were more likely to use SPH equipment and practices, have received training in the use of SPH equipment and practices, agree that the use of SPH equipment and practices is feasible, and feel confident using SPH equipment and practices. The study might not reflect the perceptions and practices of the population of acute care physical therapists. Acute care physical therapists are trained to use SPH equipment and practices, use SPH equipment and practices, and have positive perceptions regarding SPH. Acute care physical therapists in a facility with an SPH program are more likely to use SPH equipment and practices, receive training in SPH equipment and practices, and have positive perceptions regarding SPH. Quasi-regulatory organizations should incorporate SPH programs into their evaluative standards.
Population gradient in the Sextans dSph: comprehensive mapping of a dwarf galaxy by Suprime-Cam
NASA Astrophysics Data System (ADS)
Okamoto, S.; Arimoto, N.; Tolstoy, E.; Jablonka, P.; Irwin, M. J.; Komiyama, Y.; Yamada, Y.; Onodera, M.
2017-05-01
We present the deep and wide V and Ic photometry of the Sextans dwarf spheroidal galaxy (dSph) taken by the Suprime-Cam imager on the Subaru Telescope, which extends out to the tidal radius. The colour-magnitude diagram (CMD) reaches two magnitudes below the main-sequence (MS) turn-off, showing a steep red giant branch, a blue and a red horizontal branch (BHB and RHB, respectively), a sub-giant branch (SGB), an MS and blue stragglers (BSs). We construct the radial profile of each evolutionary phase and demonstrate that blue HB stars are more spatially extended, while red HB stars are more centrally concentrated than the other components. The colour distribution of SGB stars also varies with the galactocentric distance; the inner SGB stars shift bluer than those in the outskirts. The radial differences in the CMD morphology indicate the existence of the age gradient. The relatively younger stars (˜10 Gyr) are more centrally concentrated than the older ones (˜13 Gyr). The spatial contour maps of stars in different age bins also show that the younger population has a higher concentration and higher ellipticity than the older one. We also detect the centrally concentrated bright BS stars, the number of which is consistent with the idea that a part of these stars belongs to the remnant of a disrupted star cluster discovered in the previous spectroscopic studies.
NASA Astrophysics Data System (ADS)
Nafari, Mona; Aizin, Gregory R.; Jornet, Josep M.
2017-05-01
Wireless data rates have doubled every eighteen months for the last three decades. Following this trend, Terabit-per-second links will become a reality within the next five years. In this context, Terahertz (THz) band (0.1-10 THz) communication is envisioned as a key technology of the next decade. Despite major progress towards developing THz sources, compact signal generators above 1 THz able to efficiently work at room temperature are still missing. Recently, the use of hybrid graphene/semiconductor high-electron-mobility transistors (HEMT) has been proposed as a way to generate Surface Plasmon Polariton (SPP) waves at THz frequencies. Compact size, room-temperature operation and tunability of the graphene layer, in addition to possibility for large scale integration, motivate the exploration of this approach. In this paper, a simulation model of hybrid graphene/semiconductor HEMT-based THz sources is developed. More specifically, first, the necessary conditions for the so-called Dyakonov-Shur instability to arise within the HEMT channel are derived, and the impact of imperfect boundary conditions is analyzed. Second, the required conditions for coupling between a confined plasma wave in the HEMT channel and a SPP wave in graphene are derived, by starting from the coupling analysis between two 2DEG. Multi-physics simulation are conducted by integrating the hydrodynamic equations for the description of the HEMT device with Maxwell's equations for SPP modeling. Extensive results are provided to analyze the impact of different design elements on the THz signal source. This work will guide the experimental fabrication and characterization of the devices.
Performance of multi-physics ensembles in convective precipitation events over northeastern Spain
NASA Astrophysics Data System (ADS)
García-Ortega, E.; Lorenzana, J.; Merino, A.; Fernández-González, S.; López, L.; Sánchez, J. L.
2017-07-01
Convective precipitation with hail greatly affects southwestern Europe, causing major economic losses. The local character of this meteorological phenomenon is a serious obstacle to forecasting. Therefore, the development of reliable short-term forecasts constitutes an essential challenge to minimizing and managing risks. However, deterministic outcomes are affected by different uncertainty sources, such as physics parameterizations. This study examines the performance of different combinations of physics schemes of the Weather Research and Forecasting model to describe the spatial distribution of precipitation in convective environments with hail falls. Two 30-member multi-physics ensembles, with two and three domains of maximum resolution 9 and 3km each, were designed using various combinations of cumulus, microphysics and radiation schemes. The experiment was evaluated for 10 convective precipitation days with hail over 2005-2010 in northeastern Spain. Different indexes were used to evaluate the ability of each ensemble member to capture the precipitation patterns, which were compared with observations of a rain-gauge network. A standardized metric was constructed to identify optimal performers. Results show interesting differences between the two ensembles. In two domain simulations, the selection of cumulus parameterizations was crucial, with the Betts-Miller-Janjic scheme the best. In contrast, the Kain-Fristch cumulus scheme gave the poorest results, suggesting that it should not be used in the study area. Nevertheless, in three domain simulations, the cumulus schemes used in coarser domains were not critical and the best results depended mainly on microphysics schemes. The best performance was shown by Morrison, New Thomson and Goddard microphysics.
Concatenated Coding Using Trellis-Coded Modulation
NASA Technical Reports Server (NTRS)
Thompson, Michael W.
1997-01-01
In the late seventies and early eighties a technique known as Trellis Coded Modulation (TCM) was developed for providing spectrally efficient error correction coding. Instead of adding redundant information in the form of parity bits, redundancy is added at the modulation stage thereby increasing bandwidth efficiency. A digital communications system can be designed to use bandwidth-efficient multilevel/phase modulation such as Amplitude Shift Keying (ASK), Phase Shift Keying (PSK), Differential Phase Shift Keying (DPSK) or Quadrature Amplitude Modulation (QAM). Performance gain can be achieved by increasing the number of signals over the corresponding uncoded system to compensate for the redundancy introduced by the code. A considerable amount of research and development has been devoted toward developing good TCM codes for severely bandlimited applications. More recently, the use of TCM for satellite and deep space communications applications has received increased attention. This report describes the general approach of using a concatenated coding scheme that features TCM and RS coding. Results have indicated that substantial (6-10 dB) performance gains can be achieved with this approach with comparatively little bandwidth expansion. Since all of the bandwidth expansion is due to the RS code we see that TCM based concatenated coding results in roughly 10-50% bandwidth expansion compared to 70-150% expansion for similar concatenated scheme which use convolution code. We stress that combined coding and modulation optimization is important for achieving performance gains while maintaining spectral efficiency.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Harrison, Cyrus; Larsen, Matt; Brugger, Eric
Strawman is a system designed to explore the in situ visualization and analysis needs of simulation code teams running multi-physics calculations on many-core HPC architectures. It porvides rendering pipelines that can leverage both many-core CPUs and GPUs to render images of simulation meshes.
DOE Office of Scientific and Technical Information (OSTI.GOV)
David Andrs; Ray Berry; Derek Gaston
The document contains the simulation results of a steady state model PWR problem with the RELAP-7 code. The RELAP-7 code is the next generation nuclear reactor system safety analysis code being developed at Idaho National Laboratory (INL). The code is based on INL's modern scientific software development framework - MOOSE (Multi-Physics Object-Oriented Simulation Environment). This report summarizes the initial results of simulating a model steady-state single phase PWR problem using the current version of the RELAP-7 code. The major purpose of this demonstration simulation is to show that RELAP-7 code can be rapidly developed to simulate single-phase reactor problems. RELAP-7more » is a new project started on October 1st, 2011. It will become the main reactor systems simulation toolkit for RISMC (Risk Informed Safety Margin Characterization) and the next generation tool in the RELAP reactor safety/systems analysis application series (the replacement for RELAP5). The key to the success of RELAP-7 is the simultaneous advancement of physical models, numerical methods, and software design while maintaining a solid user perspective. Physical models include both PDEs (Partial Differential Equations) and ODEs (Ordinary Differential Equations) and experimental based closure models. RELAP-7 will eventually utilize well posed governing equations for multiphase flow, which can be strictly verified. Closure models used in RELAP5 and newly developed models will be reviewed and selected to reflect the progress made during the past three decades. RELAP-7 uses modern numerical methods, which allow implicit time integration, higher order schemes in both time and space, and strongly coupled multi-physics simulations. RELAP-7 is written with object oriented programming language C++. Its development follows modern software design paradigms. The code is easy to read, develop, maintain, and couple with other codes. Most importantly, the modern software design allows the RELAP-7 code
NASA Astrophysics Data System (ADS)
Harfst, S.; Portegies Zwart, S.; McMillan, S.
2008-12-01
We present MUSE, a software framework for combining existing computational tools from different astrophysical domains into a single multi-physics, multi-scale application. MUSE facilitates the coupling of existing codes written in different languages by providing inter-language tools and by specifying an interface between each module and the framework that represents a balance between generality and computational efficiency. This approach allows scientists to use combinations of codes to solve highly-coupled problems without the need to write new codes for other domains or significantly alter their existing codes. MUSE currently incorporates the domains of stellar dynamics, stellar evolution and stellar hydrodynamics for studying generalized stellar systems. We have now reached a ``Noah's Ark'' milestone, with (at least) two available numerical solvers for each domain. MUSE can treat multi-scale and multi-physics systems in which the time- and size-scales are well separated, like simulating the evolution of planetary systems, small stellar associations, dense stellar clusters, galaxies and galactic nuclei. In this paper we describe two examples calculated using MUSE: the merger of two galaxies and an N-body simulation with live stellar evolution. In addition, we demonstrate an implementation of MUSE on a distributed computer which may also include special-purpose hardware, such as GRAPEs or GPUs, to accelerate computations. The current MUSE code base is publicly available as open source at http://muse.li.
DOE Office of Scientific and Technical Information (OSTI.GOV)
Zhai, Y.; Loesser, G.; Smith, M.
ITER diagnostic first walls (DFWs) and diagnostic shield modules (DSMs) inside the port plugs (PPs) are designed to protect diagnostic instrument and components from a harsh plasma environment and provide structural support while allowing for diagnostic access to the plasma. The design of DFWs and DSMs are driven by 1) plasma radiation and nuclear heating during normal operation 2) electromagnetic loads during plasma events and associate component structural responses. A multi-physics engineering analysis protocol for the design has been established at Princeton Plasma Physics Laboratory and it was used for the design of ITER DFWs and DSMs. The analyses weremore » performed to address challenging design issues based on resultant stresses and deflections of the DFW-DSM-PP assembly for the main load cases. ITER Structural Design Criteria for In-Vessel Components (SDC-IC) required for design by analysis and three major issues driving the mechanical design of ITER DFWs are discussed. The general guidelines for the DSM design have been established as a result of design parametric studies.« less
DOE Office of Scientific and Technical Information (OSTI.GOV)
Powell, Adam; Pati, Soobhankar
2012-03-11
Solid Oxide Membrane (SOM) Electrolysis is a new energy-efficient zero-emissions process for producing high-purity magnesium and high-purity oxygen directly from industrial-grade MgO. SOM Recycling combines SOM electrolysis with electrorefining, continuously and efficiently producing high-purity magnesium from low-purity partially oxidized scrap. In both processes, electrolysis and/or electrorefining take place in the crucible, where raw material is continuously fed into the molten salt electrolyte, producing magnesium vapor at the cathode and oxygen at the inert anode inside the SOM. This paper describes a three-dimensional multi-physics finite-element model of ionic current, fluid flow driven by argon bubbling and thermal buoyancy, and heat andmore » mass transport in the crucible. The model predicts the effects of stirring on the anode boundary layer and its time scale of formation, and the effect of natural convection at the outer wall. MOxST has developed this model as a tool for scale-up design of these closely-related processes.« less
NASA Astrophysics Data System (ADS)
Varghese, Julian
This research work has contributed in various ways to help develop a better understanding of textile composites and materials with complex microstructures in general. An instrumental part of this work was the development of an object-oriented framework that made it convenient to perform multiscale/multiphysics analyses of advanced materials with complex microstructures such as textile composites. In addition to the studies conducted in this work, this framework lays the groundwork for continued research of these materials. This framework enabled a detailed multiscale stress analysis of a woven DCB specimen that revealed the effect of the complex microstructure on the stress and strain energy release rate distribution along the crack front. In addition to implementing an oxidation model, the framework was also used to implement strategies that expedited the simulation of oxidation in textile composites so that it would take only a few hours. The simulation showed that the tow architecture played a significant role in the oxidation behavior in textile composites. Finally, a coupled diffusion/oxidation and damage progression analysis was implemented that was used to study the mechanical behavior of textile composites under mechanical loading as well as oxidation. A parametric study was performed to determine the effect of material properties and the number of plies in the laminate on its mechanical behavior. The analyses indicated a significant effect of the tow architecture and other parameters on the damage progression in the laminates.
The Formation of a Milky Way-sized Disk Galaxy. I. A Comparison of Numerical Methods
NASA Astrophysics Data System (ADS)
Zhu, Qirong; Li, Yuexing
2016-11-01
The long-standing challenge of creating a Milky Way- (MW-) like disk galaxy from cosmological simulations has motivated significant developments in both numerical methods and physical models. We investigate these two fundamental aspects in a new comparison project using a set of cosmological hydrodynamic simulations of an MW-sized galaxy. In this study, we focus on the comparison of two particle-based hydrodynamics methods: an improved smoothed particle hydrodynamics (SPH) code Gadget, and a Lagrangian Meshless Finite-Mass (MFM) code Gizmo. All the simulations in this paper use the same initial conditions and physical models, which include star formation, “energy-driven” outflows, metal-dependent cooling, stellar evolution, and metal enrichment. We find that both numerical schemes produce a late-type galaxy with extended gaseous and stellar disks. However, notable differences are present in a wide range of galaxy properties and their evolution, including star-formation history, gas content, disk structure, and kinematics. Compared to Gizmo, the Gadget simulation produced a larger fraction of cold, dense gas at high redshift which fuels rapid star formation and results in a higher stellar mass by 20% and a lower gas fraction by 10% at z = 0, and the resulting gas disk is smoother and more coherent in rotation due to damping of turbulent motion by the numerical viscosity in SPH, in contrast to the Gizmo simulation, which shows a more prominent spiral structure. Given its better convergence properties and lower computational cost, we argue that the MFM method is a promising alternative to SPH in cosmological hydrodynamic simulations.
THE FORMATION OF A MILKY WAY-SIZED DISK GALAXY. I. A COMPARISON OF NUMERICAL METHODS
DOE Office of Scientific and Technical Information (OSTI.GOV)
Zhu, Qirong; Li, Yuexing, E-mail: qxz125@psu.edu
The long-standing challenge of creating a Milky Way- (MW-) like disk galaxy from cosmological simulations has motivated significant developments in both numerical methods and physical models. We investigate these two fundamental aspects in a new comparison project using a set of cosmological hydrodynamic simulations of an MW-sized galaxy. In this study, we focus on the comparison of two particle-based hydrodynamics methods: an improved smoothed particle hydrodynamics (SPH) code Gadget, and a Lagrangian Meshless Finite-Mass (MFM) code Gizmo. All the simulations in this paper use the same initial conditions and physical models, which include star formation, “energy-driven” outflows, metal-dependent cooling, stellarmore » evolution, and metal enrichment. We find that both numerical schemes produce a late-type galaxy with extended gaseous and stellar disks. However, notable differences are present in a wide range of galaxy properties and their evolution, including star-formation history, gas content, disk structure, and kinematics. Compared to Gizmo, the Gadget simulation produced a larger fraction of cold, dense gas at high redshift which fuels rapid star formation and results in a higher stellar mass by 20% and a lower gas fraction by 10% at z = 0, and the resulting gas disk is smoother and more coherent in rotation due to damping of turbulent motion by the numerical viscosity in SPH, in contrast to the Gizmo simulation, which shows a more prominent spiral structure. Given its better convergence properties and lower computational cost, we argue that the MFM method is a promising alternative to SPH in cosmological hydrodynamic simulations.« less
Quench-Induced Stresses in AA2618 Forgings for Impellers: A Multiphysics and Multiscale Problem
NASA Astrophysics Data System (ADS)
Chobaut, Nicolas; Saelzle, Peter; Michel, Gilles; Carron, Denis; Drezet, Jean-Marie
2015-05-01
In the fabrication of heat-treatable aluminum parts such as AA2618 compressor impellers for turbochargers, solutionizing and quenching are key steps to obtain the required mechanical characteristics. Fast quenching is necessary to avoid coarse precipitation as it reduces the mechanical properties obtained after heat treatment. However, fast quenching induces residual stresses that can cause unacceptable distortions during machining. Furthermore, the remaining residual stresses after final machining can lead to unfavorable stresses in service. Predicting and controlling internal stresses during the whole processing from heat treatment to final machining is therefore of particular interest to prevent negative impacts of residual stresses. This problem is multiphysics because processes such as heat transfer during quenching, precipitation phenomena, thermally induced deformations, and stress generation are interacting and need to be taken into account. The problem is also multiscale as precipitates of nanosize form during quenching at locations where the cooling rate is too low. This precipitation affects the local yield strength of the material and thus impacts the level of macroscale residual stresses. A thermomechanical model accounting for precipitation in a simple but realistic way is presented. Instead of modelling precipitation that occurs during quenching, the model parameters are identified using a limited number of tensile tests achieved after representative interrupted cooling paths in a Gleeble machine. The simulation results are compared with as-quenched residual stresses in a forging measured by neutron diffraction.
Multiscale Multiphysics Caprock Seal Analysis: A Case Study of the Farnsworth Unit, Texas, USA
NASA Astrophysics Data System (ADS)
Heath, J. E.; Dewers, T. A.; Mozley, P.
2015-12-01
Caprock sealing behavior depends on coupled processes that operate over a variety of length and time scales. Capillary sealing behavior depends on nanoscale pore throats and interfacial fluid properties. Larger-scale sedimentary architecture, fractures, and faults may govern properties of potential "seal-bypass" systems. We present the multiscale multiphysics investigation of sealing integrity of the caprock system that overlies the Morrow Sandstone reservoir, Farnsworth Unit, Texas. The Morrow Sandstone is the target injection unit for an on-going combined enhanced oil recovery-CO2 storage project by the Southwest Regional Partnership on Carbon Sequestration (SWP). Methods include small-to-large scale measurement techniques, including: focused ion beam-scanning electron microscopy; laser scanning confocal microscopy; electron and optical petrography; core examinations of sedimentary architecture and fractures; geomechanical testing; and a noble gas profile through sealing lithologies into the reservoir, as preserved from fresh core. The combined data set is used as part of a performance assessment methodology. The authors gratefully acknowledge the U.S. Department of Energy's (DOE) National Energy Technology Laboratory for sponsoring this project through the SWP under Award No. DE-FC26-05NT42591. Sandia National Laboratories is a multi-program laboratory managed and operated by Sandia Corporation, a wholly owned subsidiary of Lockheed Martin Corporation, for the U.S. Department of Energy's National Nuclear Security Administration under contract DE-AC04-94AL85000.
Tidal disruption of inviscid planetesimals
NASA Technical Reports Server (NTRS)
Boss, A. P.; Cameron, A. G. W.; Benz, W.
1991-01-01
In view of previous efforts' demonstration that strongly dissipative planetesimals are immune to tidal disruption, an examination is presently conducted of the complementary case of inviscid planetesimals arising from collisions that are sufficiently energetic to entirely melt the resulting planetesimal and debris. The tidal disruption is numerically simulated by means of the smoothed particle hydrodynamics (SPH) code of Cameron and Benz (1991), concentrating on the tidal disruption of 0.01 earth-mass planetesimals passing by the earth with variations in the impact parameter at perigee and velocity at infinity. The SPH models show that tidal forces during a close encounter can efficiently convert orbital angular momentum into spin angular momentum, thereby initiating equatorial mass-shedding to inviscid planetesimals that have been spun up beyond the limit of rotational stability.
Yamaji, Minoru; Horimoto, Ami; Marciniak, Bronislaw
2017-07-14
We have prepared three types of carbonyl compounds, benzoylethynylmethyl phenyl sulfide (2@SPh), (p-benzoyl)phenylethynylmethyl phenyl sulfide (3@SPh) and p-(benzoylethynyl)benzyl phenyl sulfide (4@SPh) with benzoyl and phenylthiylmethyl groups, which are interconnected with a C-C triple bond and a phenyl ring. Laser flash photolysis of 3@SPh and 4@SPh in acetonitrile provided the transient absorption spectra of the corresponding triplet states where no chemical reactions were recognized. Upon laser flash photolysis of 2@SPh, the absorption band due to the phenylthiyl radical (PTR) was obtained, indicating that the C-S bond cleaved in the excited state. Triplet sensitization of these carbonyl compounds using acetone and xanthone was conducted using laser photolysis techniques. The formation of triplet 3@SPh was seen in the transient absorption, whereas the PTR formation was observed for 2@SPh and 4@SPh, indicating that the triplet states were reactive for the C-S bond dissociation. The C-S bond dissociation mechanism for 4@SPh upon triplet sensitization is discussed in comparison with those for 2@SPh and 3@SPh.
Report from the Integrated Modeling Panel at the Workshop on the Science of Ignition on NIF
DOE Office of Scientific and Technical Information (OSTI.GOV)
Marinak, M; Lamb, D
2012-07-03
This section deals with multiphysics radiation hydrodynamics codes used to design and simulate targets in the ignition campaign. These topics encompass all the physical processes they model, and include consideration of any approximations necessary due to finite computer resources. The section focuses on what developments would have the highest impact on reducing uncertainties in modeling most relevant to experimental observations. It considers how the ICF codes should be employed in the ignition campaign. This includes a consideration of how the experiments can be best structured to test the physical models the codes employ.
Self-complementary circular codes in coding theory.
Fimmel, Elena; Michel, Christian J; Starman, Martin; Strüngmann, Lutz
2018-04-01
Self-complementary circular codes are involved in pairing genetic processes. A maximal [Formula: see text] self-complementary circular code X of trinucleotides was identified in genes of bacteria, archaea, eukaryotes, plasmids and viruses (Michel in Life 7(20):1-16 2017, J Theor Biol 380:156-177, 2015; Arquès and Michel in J Theor Biol 182:45-58 1996). In this paper, self-complementary circular codes are investigated using the graph theory approach recently formulated in Fimmel et al. (Philos Trans R Soc A 374:20150058, 2016). A directed graph [Formula: see text] associated with any code X mirrors the properties of the code. In the present paper, we demonstrate a necessary condition for the self-complementarity of an arbitrary code X in terms of the graph theory. The same condition has been proven to be sufficient for codes which are circular and of large size [Formula: see text] trinucleotides, in particular for maximal circular codes ([Formula: see text] trinucleotides). For codes of small-size [Formula: see text] trinucleotides, some very rare counterexamples have been constructed. Furthermore, the length and the structure of the longest paths in the graphs associated with the self-complementary circular codes are investigated. It has been proven that the longest paths in such graphs determine the reading frame for the self-complementary circular codes. By applying this result, the reading frame in any arbitrary sequence of trinucleotides is retrieved after at most 15 nucleotides, i.e., 5 consecutive trinucleotides, from the circular code X identified in genes. Thus, an X motif of a length of at least 15 nucleotides in an arbitrary sequence of trinucleotides (not necessarily all of them belonging to X) uniquely defines the reading (correct) frame, an important criterion for analyzing the X motifs in genes in the future.
Coset Codes Viewed as Terminated Convolutional Codes
NASA Technical Reports Server (NTRS)
Fossorier, Marc P. C.; Lin, Shu
1996-01-01
In this paper, coset codes are considered as terminated convolutional codes. Based on this approach, three new general results are presented. First, it is shown that the iterative squaring construction can equivalently be defined from a convolutional code whose trellis terminates. This convolutional code determines a simple encoder for the coset code considered, and the state and branch labelings of the associated trellis diagram become straightforward. Also, from the generator matrix of the code in its convolutional code form, much information about the trade-off between the state connectivity and complexity at each section, and the parallel structure of the trellis, is directly available. Based on this generator matrix, it is shown that the parallel branches in the trellis diagram of the convolutional code represent the same coset code C(sub 1), of smaller dimension and shorter length. Utilizing this fact, a two-stage optimum trellis decoding method is devised. The first stage decodes C(sub 1), while the second stage decodes the associated convolutional code, using the branch metrics delivered by stage 1. Finally, a bidirectional decoding of each received block starting at both ends is presented. If about the same number of computations is required, this approach remains very attractive from a practical point of view as it roughly doubles the decoding speed. This fact is particularly interesting whenever the second half of the trellis is the mirror image of the first half, since the same decoder can be implemented for both parts.
Combinatorial neural codes from a mathematical coding theory perspective.
Curto, Carina; Itskov, Vladimir; Morrison, Katherine; Roth, Zachary; Walker, Judy L
2013-07-01
Shannon's seminal 1948 work gave rise to two distinct areas of research: information theory and mathematical coding theory. While information theory has had a strong influence on theoretical neuroscience, ideas from mathematical coding theory have received considerably less attention. Here we take a new look at combinatorial neural codes from a mathematical coding theory perspective, examining the error correction capabilities of familiar receptive field codes (RF codes). We find, perhaps surprisingly, that the high levels of redundancy present in these codes do not support accurate error correction, although the error-correcting performance of receptive field codes catches up to that of random comparison codes when a small tolerance to error is introduced. However, receptive field codes are good at reflecting distances between represented stimuli, while the random comparison codes are not. We suggest that a compromise in error-correcting capability may be a necessary price to pay for a neural code whose structure serves not only error correction, but must also reflect relationships between stimuli.
Software Certification - Coding, Code, and Coders
NASA Technical Reports Server (NTRS)
Havelund, Klaus; Holzmann, Gerard J.
2011-01-01
We describe a certification approach for software development that has been adopted at our organization. JPL develops robotic spacecraft for the exploration of the solar system. The flight software that controls these spacecraft is considered to be mission critical. We argue that the goal of a software certification process cannot be the development of "perfect" software, i.e., software that can be formally proven to be correct under all imaginable and unimaginable circumstances. More realistically, the goal is to guarantee a software development process that is conducted by knowledgeable engineers, who follow generally accepted procedures to control known risks, while meeting agreed upon standards of workmanship. We target three specific issues that must be addressed in such a certification procedure: the coding process, the code that is developed, and the skills of the coders. The coding process is driven by standards (e.g., a coding standard) and tools. The code is mechanically checked against the standard with the help of state-of-the-art static source code analyzers. The coders, finally, are certified in on-site training courses that include formal exams.
Dynamic Fracture Simulations of Explosively Loaded Cylinders
DOE Office of Scientific and Technical Information (OSTI.GOV)
Arthur, Carly W.; Goto, D. M.
2015-11-30
This report documents the modeling results of high explosive experiments investigating dynamic fracture of steel (AerMet® 100 alloy) cylinders. The experiments were conducted at Lawrence Livermore National Laboratory (LLNL) during 2007 to 2008 [10]. A principal objective of this study was to gain an understanding of dynamic material failure through the analysis of hydrodynamic computer code simulations. Two-dimensional and three-dimensional computational cylinder models were analyzed using the ALE3D multi-physics computer code.
Ariane, Mostapha; Kassinos, Stavros; Velaga, Sitaram; Alexiadis, Alessio
2018-04-01
In this paper, the mass transfer coefficient (permeability) of boundary layers containing motile cilia is investigated by means of discrete multi-physics. The idea is to understand the main mechanisms of mass transport occurring in a ciliated-layer; one specific application being inhaled drugs in the respiratory epithelium. The effect of drug diffusivity, cilia beat frequency and cilia flexibility is studied. Our results show the existence of three mass transfer regimes. A low frequency regime, which we called shielding regime, where the presence of the cilia hinders mass transport; an intermediate frequency regime, which we have called diffusive regime, where diffusion is the controlling mechanism; and a high frequency regime, which we have called convective regime, where the degree of bending of the cilia seems to be the most important factor controlling mass transfer in the ciliated-layer. Since the flexibility of the cilia and the frequency of the beat changes with age and health conditions, the knowledge of these three regimes allows prediction of how mass transfer varies with these factors. Copyright © 2018 Elsevier Ltd. All rights reserved.
Utility of human hepatocyte spheroids without feeder cells for evaluation of hepatotoxicity.
Ogihara, Takuo; Arakawa, Hiroshi; Jomura, Tomoko; Idota, Yoko; Koyama, Satoshi; Yano, Kentaro; Kojima, Hajime
2017-01-01
We investigated the utility of three-dimensionally cultured hepatocytes (spheroids) without feeder cells (Sph(f-)) for the prediction of drug-induced liver injury (DILI) in humans. Sph(f-) and spheroids cultured on feeder cells (Sph(f+)) were exposed to the hepatotoxic drugs flutamide, diclofenac, isoniazid and chlorpromazine at various concentrations for 14 days, and albumin secretion and cumulative leakages of toxicity marker enzymes, aspartate aminotransferase (AST), alanine aminotransferase (ALT), lactate dehydrogenase (LDH) and γ-glutamyl transpeptidase (γ-GTP), were measured. The cumulative AST, LDH or γ-GTP leakages from Sph(f-) were similar to or greater than those from Sph(f+) for all drugs tested, although ALT leakages showed no consistent difference between Sph(f+) and Sph(f-). In the case of Sph(f-), significant correlations among all the toxicity markers except for γ-GTP were observed. As regards the drug concentrations causing 1.2-fold elevation of enzyme leakage (F 1.2 ), no consistent difference between Sph(f+) and Sph(f-) was found, although several F 1.2 values were undetermined, especially in Sph(f+). The IC 50 of albumin secretion and F 1.2 of AST leakage from Sph(f-) were equal to or lower than those of Sph(f+) for all the tested drugs. These results indicate that feeder cells might contribute to resistance to hepatotoxicity, suggesting DILI could be evaluated more accurately by using Sph(f-). We suggest that long-term exposure of Sph(f-) to drugs might be a versatile method to predict and reproduce clinical chronic toxicity, especially in response to repeated drug administration.
Slattery, Stuart R.
2015-12-02
In this study we analyze and extend mesh-free algorithms for three-dimensional data transfer problems in partitioned multiphysics simulations. We first provide a direct comparison between a mesh-based weighted residual method using the common-refinement scheme and two mesh-free algorithms leveraging compactly supported radial basis functions: one using a spline interpolation and one using a moving least square reconstruction. Through the comparison we assess both the conservation and accuracy of the data transfer obtained from each of the methods. We do so for a varying set of geometries with and without curvature and sharp features and for functions with and without smoothnessmore » and with varying gradients. Our results show that the mesh-based and mesh-free algorithms are complementary with cases where each was demonstrated to perform better than the other. We then focus on the mesh-free methods by developing a set of algorithms to parallelize them based on sparse linear algebra techniques. This includes a discussion of fast parallel radius searching in point clouds and restructuring the interpolation algorithms to leverage data structures and linear algebra services designed for large distributed computing environments. The scalability of our new algorithms is demonstrated on a leadership class computing facility using a set of basic scaling studies. Finally, these scaling studies show that for problems with reasonable load balance, our new algorithms for both spline interpolation and moving least square reconstruction demonstrate both strong and weak scalability using more than 100,000 MPI processes with billions of degrees of freedom in the data transfer operation.« less
Discussion on LDPC Codes and Uplink Coding
NASA Technical Reports Server (NTRS)
Andrews, Ken; Divsalar, Dariush; Dolinar, Sam; Moision, Bruce; Hamkins, Jon; Pollara, Fabrizio
2007-01-01
This slide presentation reviews the progress that the workgroup on Low-Density Parity-Check (LDPC) for space link coding. The workgroup is tasked with developing and recommending new error correcting codes for near-Earth, Lunar, and deep space applications. Included in the presentation is a summary of the technical progress of the workgroup. Charts that show the LDPC decoder sensitivity to symbol scaling errors are reviewed, as well as a chart showing the performance of several frame synchronizer algorithms compared to that of some good codes and LDPC decoder tests at ESTL. Also reviewed is a study on Coding, Modulation, and Link Protocol (CMLP), and the recommended codes. A design for the Pseudo-Randomizer with LDPC Decoder and CRC is also reviewed. A chart that summarizes the three proposed coding systems is also presented.
Sphingosine kinase 1 mediates AGEs-induced fibronectin upregulation in diabetic nephropathy.
Chen, Cheng; Gong, Wenyan; Li, Changzheng; Xiong, Fengxiao; Wang, Shaogui; Huang, Junying; Wang, Yu; Chen, Zhiquan; Chen, Qiuhong; Liu, Peiqing; Lan, Tian; Huang, Heqing
2017-10-03
Activation of sphingosine kinase 1 (SphK1) signaling pathway mediates fibronectin (FN) upregulation in glomerular mesangial cells (GMCs) under high glucose (HG) condition. However, the roles of SphK1 in advanced glycation end products (AGEs)-induced DN have not been elucidated. Here we show that AGEs upregulated FN and SphK1 and SphK1 activity. Inhibition of SphK1 signaling attenuated AGEs-induced FN synthesis in GMCs. Inhibition of AGE receptor (RAGE) signaling reduced the upregulation of FN and SphK1 and SphK1 activity in GMCs induced by AGEs. Treatment of aminoguanidine ameliorates the renal injury and fibrosis in STZ-induced diabetic mice and attenuated SphK1 expression and activity in diabetic mouse kidneys. The renal injury and fibrosis in diabetic SphK1 -/- mice was significantly attenuated than WT mice. Furthermore, AGEs upregulated SphK1 by reducing its degradation and prolonging its half-life. SphK1 mediates AGEs-induced FN synthesis in GMCs and diabetic mice under hyperglycemic condition .
Sphingosine kinase 1 mediates AGEs-induced fibronectin upregulation in diabetic nephropathy
Chen, Cheng; Gong, Wenyan; Li, Changzheng; Xiong, Fengxiao; Wang, Shaogui; Huang, Junying; Wang, Yu; Chen, Zhiquan; Chen, Qiuhong; Liu, Peiqing; Lan, Tian; Huang, Heqing
2017-01-01
Activation of sphingosine kinase 1 (SphK1) signaling pathway mediates fibronectin (FN) upregulation in glomerular mesangial cells (GMCs) under high glucose (HG) condition. However, the roles of SphK1 in advanced glycation end products (AGEs)-induced DN have not been elucidated. Here we show that AGEs upregulated FN and SphK1 and SphK1 activity. Inhibition of SphK1 signaling attenuated AGEs-induced FN synthesis in GMCs. Inhibition of AGE receptor (RAGE) signaling reduced the upregulation of FN and SphK1 and SphK1 activity in GMCs induced by AGEs. Treatment of aminoguanidine ameliorates the renal injury and fibrosis in STZ-induced diabetic mice and attenuated SphK1 expression and activity in diabetic mouse kidneys. The renal injury and fibrosis in diabetic SphK1-/- mice was significantly attenuated than WT mice. Furthermore, AGEs upregulated SphK1 by reducing its degradation and prolonging its half-life. Conclusion: SphK1 mediates AGEs-induced FN synthesis in GMCs and diabetic mice under hyperglycemic condition. PMID:29108256
A real-time high-throughput fluorescence assay for sphingosine kinases
Lima, Santiago; Milstien, Sheldon; Spiegel, Sarah
2014-01-01
Sphingosine kinases (SphKs), of which there are two isoforms, SphK1 and SphK2, have been implicated in regulation of many important cellular processes. We have developed an assay for monitoring SphK1 and SphK2 activity in real time without the need for organic partitioning of products, radioactive materials, or specialized equipment. The assay conveniently follows SphK-dependent changes in 7-nitro-2-1,3-benzoxadiazol-4-yl (NBD)-labeled sphingosine (Sph) fluorescence and can be easily performed in 384-well plate format with small reaction volumes. We present data showing dose-proportional responses to enzyme, substrate, and inhibitor concentrations. The SphK1 and SphK2 binding affinities for NBD-Sph and the IC50 values of inhibitors determined were consistent with those reported with other methods. Because of the versatility and simplicity of the assay, it should facilitate the routine characterization of inhibitors and SphK mutants and can be readily used for compound library screening in high-throughput format. PMID:24792926
Practices in Code Discoverability: Astrophysics Source Code Library
NASA Astrophysics Data System (ADS)
Allen, A.; Teuben, P.; Nemiroff, R. J.; Shamir, L.
2012-09-01
Here we describe the Astrophysics Source Code Library (ASCL), which takes an active approach to sharing astrophysics source code. ASCL's editor seeks out both new and old peer-reviewed papers that describe methods or experiments that involve the development or use of source code, and adds entries for the found codes to the library. This approach ensures that source codes are added without requiring authors to actively submit them, resulting in a comprehensive listing that covers a significant number of the astrophysics source codes used in peer-reviewed studies. The ASCL now has over 340 codes in it and continues to grow. In 2011, the ASCL has on average added 19 codes per month. An advisory committee has been established to provide input and guide the development and expansion of the new site, and a marketing plan has been developed and is being executed. All ASCL source codes have been used to generate results published in or submitted to a refereed journal and are freely available either via a download site or from an identified source. This paper provides the history and description of the ASCL. It lists the requirements for including codes, examines the advantages of the ASCL, and outlines some of its future plans.
Baker, DeAnna A; Barth, Jeremy; Chang, Raymond; Obeid, Lina M; Gilkeson, Gary S
2010-08-15
Sphingosine kinase 1 (SphK1) is an enzyme that converts sphingosine to bioactive sphingosine-1-phosphate. Recent in vitro data suggest a potential role of SphK1 in TNF-alpha-mediated inflammation. Our aims in this study were to determine the in vivo significance of SphK1 in TNF-alpha-mediated chronic inflammation and to define which pathogenic mechanisms induced by TNF-alpha are SphK1 dependent. To pursue these aims, we studied the effect of SphK1 deficiency in an in vivo model of TNF-alpha-induced chronic inflammatory arthritis. Transgenic hTNF-alpha mice, which develop spontaneous inflammatory erosive arthritis beginning at 14-16 wk, were crossed with SphK1 null mice (SphK1(-/-)), on the C57BL6 genetic background. Beginning at 4 mo of age, hTNF/SphK1(-/-) mice had significantly less severe clinically evident paw swelling and deformity, less synovial and periarticular inflammation, and markedly decreased bone erosions as measured quantitatively through micro-CT images. Mechanistically, the mice lacking SphK1 had less articular cyclooxygenase 2 protein and fewer synovial Th17 cells than did hTNF/SphK1(+/+) littermates. Microarray analysis and real-time RT-PCR of the ankle synovial tissue demonstrated that hTNF/SphK1(-/-) mice had increased transcript levels of suppressor of cytokine signaling 3 compared with hTNF/SphK1(+/+) mice, likely also contributing to the decreased inflammation in the SphK1-deficient mice. Finally, significantly fewer mature osteoclasts were detected in the ankle joints of hTNF/SphK1(-/-) mice compared with hTNF/SphK1(+/+) mice. These data indicate that SphK1 plays a key role in hTNF-alpha-induced inflammatory arthritis via impacting synovial inflammation and osteoclast number.
Anisotropic diffusion in mesh-free numerical magnetohydrodynamics
NASA Astrophysics Data System (ADS)
Hopkins, Philip F.
2017-04-01
We extend recently developed mesh-free Lagrangian methods for numerical magnetohydrodynamics (MHD) to arbitrary anisotropic diffusion equations, including: passive scalar diffusion, Spitzer-Braginskii conduction and viscosity, cosmic ray diffusion/streaming, anisotropic radiation transport, non-ideal MHD (Ohmic resistivity, ambipolar diffusion, the Hall effect) and turbulent 'eddy diffusion'. We study these as implemented in the code GIZMO for both new meshless finite-volume Godunov schemes (MFM/MFV). We show that the MFM/MFV methods are accurate and stable even with noisy fields and irregular particle arrangements, and recover the correct behaviour even in arbitrarily anisotropic cases. They are competitive with state-of-the-art AMR/moving-mesh methods, and can correctly treat anisotropic diffusion-driven instabilities (e.g. the MTI and HBI, Hall MRI). We also develop a new scheme for stabilizing anisotropic tensor-valued fluxes with high-order gradient estimators and non-linear flux limiters, which is trivially generalized to AMR/moving-mesh codes. We also present applications of some of these improvements for SPH, in the form of a new integral-Godunov SPH formulation that adopts a moving-least squares gradient estimator and introduces a flux-limited Riemann problem between particles.
New quantum codes constructed from quaternary BCH codes
NASA Astrophysics Data System (ADS)
Xu, Gen; Li, Ruihu; Guo, Luobin; Ma, Yuena
2016-10-01
In this paper, we firstly study construction of new quantum error-correcting codes (QECCs) from three classes of quaternary imprimitive BCH codes. As a result, the improved maximal designed distance of these narrow-sense imprimitive Hermitian dual-containing quaternary BCH codes are determined to be much larger than the result given according to Aly et al. (IEEE Trans Inf Theory 53:1183-1188, 2007) for each different code length. Thus, families of new QECCs are newly obtained, and the constructed QECCs have larger distance than those in the previous literature. Secondly, we apply a combinatorial construction to the imprimitive BCH codes with their corresponding primitive counterpart and construct many new linear quantum codes with good parameters, some of which have parameters exceeding the finite Gilbert-Varshamov bound for linear quantum codes.
Zupancic, Eva; Carreira, Ana C; de Almeida, Rodrigo F M; Silva, Liana C
2014-05-08
Sphingosine (Sph) is a simple lipid involved in the regulation of several biological processes. When accumulated in the late endosomal/lysosomal compartments, Sph causes changes in ion signaling and membrane trafficking, leading to the development of Niemann-Pick disease type C. Little is known about Sph interaction with other lipids in biological membranes; however, understanding the effect of Sph in the physical state of membranes might provide insights into its mode of action. Using complementary established fluorescence approaches, we show that Sph accumulation leads to the formation of Sph-enriched gel domains in 1-palmitoyl-2-oleoyl-sn-glycero-3-phosphocholine (POPC) and POPC/sphingomyelin (SM)/cholesterol (Chol) model membranes. These domains are more easily formed in membrane models mimicking the neutral pH plasma membrane environment (PM) as compared to the acidic lysosomal membrane environment (LM), where higher Sph concentrations (or lower temperatures) are required. Electrophoretic light scattering measurements further revealed that in PM-raft models (POPC/SM/Chol), Sph is mainly neutral, whereas in LM models, the positive charge of Sph leads to electrostatic repulsion, reducing the Sph ability to form gel domains. Thus, formation of Sph-enriched domains in cellular membranes might be strongly regulated by Sph charge.
Multiphysics control of a two-fluid coaxial atomizer supported by electric-charge on the liquid jet
NASA Astrophysics Data System (ADS)
Machicoane, Nathanael; Osuna, Rodrigo; Aliseda, Alberto
2017-11-01
We present an experimental setup to investigate multiphysics control strategies on atomization of a laminar fluid stream by a coaxial turbulent jet. Spray control (i.e. driving the droplet size distribution and the spatio-temporal location of the droplets towards a desired objective) has many potential engineering applications, but requires a mechanistic understanding of the processes that control droplet formation and transport (primary and secondary instabilities, turbulent transport, hydrodynamic and electric forces on the droplets, ...). We characterize experimentally the break-up dynamics in a canonical coaxial atomizer, and the spray structure (droplet size, location, and velocity as a function of time) in a series of open loop conditions with harmonic forcing of the gas swirl ratio, liquid injection rate, the electric field strength at the nozzle and along the spray development region. The effect of these actuators are characterized for different gas Reynolds numbers ranging from 104-106. This open-loop characterization of the injector will be used to develop reduced order models for feedback control, as well as to validate assumptions underlying an adjoint-based computational control strategy. This work is part of a large-scale project funded by an ONR MURI to provide fundamental understanding of the mechanisms for feedback control of sprays.
A multi-physics study of Li-ion battery material Li1+xTi2O4
NASA Astrophysics Data System (ADS)
Jiang, Tonghu; Falk, Michael; Siva Shankar Rudraraju, Krishna; Garikipati, Krishna; van der Ven, Anton
2013-03-01
Recently, lithium ion batteries have been subject to intense scientific study due to growing demand arising from their utilization in portable electronics, electric vehicles and other applications. Most cathode materials in lithium ion batteries involve a two-phase process during charging and discharging, and the rate of these processes is typically limited by the slow interface mobility. We have undertaken modeling regarding how lithium diffusion in the interface region affects the motion of the phase boundary. We have developed a multi-physics computational method suitable for predicting time evolution of the driven interface. In this method, we calculate formation energies and migration energy barriers by ab initio methods, which are then approximated by cluster expansions. Monte Carlo calculation is further employed to obtain thermodynamic and kinetic information, e.g., anisotropic interfacial energies, and mobilities, which are used to parameterize continuum modeling of the charging and discharging processes. We test this methodology on spinel Li1+xTi2O4. Elastic effects are incorporated into the calculations to determine the effect of variations in modulus and strain on stress concentrations and failure modes within the material. We acknowledge support by the National Science Foundation Cyber Discovery and Innovation Program under Award No. 1027765.
NASA Astrophysics Data System (ADS)
Hwang, Yong Seok
It has been found during the last decade that a nanoscale melting of metal has very distinctive features compared to its microscale counterpart. It has been observed that a highly non-equilibrium state can result in extreme superheating of a solid state, which cannot be explained well by thermodynamic theories based on equilibrium or nucleation. An endeavor to find the superheating limit and mechanisms of melting and superheating becomes more complicated when various physical phenomena are involved at the similar scales. The main goal of this research is to establish a multiphysics model and to reveal the mechanism of melting and kinetic superheating of a metal nanostructure at high heating rates. The model includes elastodynamics, a fast heating of metal considering a delayed heat transfer between electron gas and lattice phonon and couplings among physical phenomena, and phase transformation incorporated with thermal fluctuation. The model successfully reproduces two independent experiments and several novel nanoscale physical phenomena are discovered. For example, the depression of the melting temperature of Al nanolayer under plane stress condition, the threshold heating rate, 1011 K/s, for kinetic superheating, a large temperature drop in a 5 nm collision region of the two solid-melt interfaces, and a strong effect of geometry on kinetic superheating in Al core-shell nanostructure at high heating rate.
Lavenn, Christophe; Albrieux, Florian; Tuel, Alain; Demessence, Aude
2014-03-15
Research interest in ultra small gold thiolate clusters has been rising in recent years for the challenges they offer to bring together properties of nanoscience and well-defined materials from molecular chemistry. Here, a new atomically well-defined Au10 gold nanocluster surrounded by ten 4-aminothiophenolate ligands is reported. Its synthesis followed the similar conditions reported for the elaboration of Au144(SR)60, but because the reactivity of thiophenol ligands is different from alkanethiol derivates, smaller Au10 clusters were formed. Different techniques, such as ESI-MS, elemental analysis, XRD, TGA, XPS and UV-vis-NIR experiments, have been carried out to determine the Au10(SPh-pNH2)10 formula. Photoemission experiment has been done and reveals that the Au10 clusters are weakly luminescent as opposed to the amino-based ultra-small gold clusters. This observation points out that the emission of gold thiolate clusters is highly dependent on both the structure of the gold core and the type of the ligands at the surface. In addition, ultra-small amino-functionalized clusters offer the opportunity for extended work on self-assembling networks or deposition on substrates for nanotechnologies or catalytic applications. Copyright © 2013 Elsevier Inc. All rights reserved.
Fast and accurate Voronoi density gridding from Lagrangian hydrodynamics data
NASA Astrophysics Data System (ADS)
Petkova, Maya A.; Laibe, Guillaume; Bonnell, Ian A.
2018-01-01
Voronoi grids have been successfully used to represent density structures of gas in astronomical hydrodynamics simulations. While some codes are explicitly built around using a Voronoi grid, others, such as Smoothed Particle Hydrodynamics (SPH), use particle-based representations and can benefit from constructing a Voronoi grid for post-processing their output. So far, calculating the density of each Voronoi cell from SPH data has been done numerically, which is both slow and potentially inaccurate. This paper proposes an alternative analytic method, which is fast and accurate. We derive an expression for the integral of a cubic spline kernel over the volume of a Voronoi cell and link it to the density of the cell. Mass conservation is ensured rigorously by the procedure. The method can be applied more broadly to integrate a spherically symmetric polynomial function over the volume of a random polyhedron.
A method of smoothed particle hydrodynamics using spheroidal kernels
NASA Technical Reports Server (NTRS)
Fulbright, Michael S.; Benz, Willy; Davies, Melvyn B.
1995-01-01
We present a new method of three-dimensional smoothed particle hydrodynamics (SPH) designed to model systems dominated by deformation along a preferential axis. These systems cause severe problems for SPH codes using spherical kernels, which are best suited for modeling systems which retain rough spherical symmetry. Our method allows the smoothing length in the direction of the deformation to evolve independently of the smoothing length in the perpendicular plane, resulting in a kernel with a spheroidal shape. As a result the spatial resolution in the direction of deformation is significantly improved. As a test case we present the one-dimensional homologous collapse of a zero-temperature, uniform-density cloud, which serves to demonstrate the advantages of spheroidal kernels. We also present new results on the problem of the tidal disruption of a star by a massive black hole.
Composition control and localization of S2- in CdSSe quantum dots grown from Li4[Cd10Se4(SPh)16].
Lovingood, Derek D; Oyler, Ryan E; Strouse, Geoffrey F
2008-12-17
The development of ternary nanoscale materials with controlled cross-sectional doping is an important step for the use of chemically prepared quantum dots for nanoscale engineering applications. We report cross-sectional, elemental doping with the formation of an alloyed CdSSe nanocrystal from the thermal decomposition of Li(4)[Cd(10)Se(4)(SPh)(16)]. The sulfur incorporation arises from surface-mediated phenylthiolate degradation on the growing quantum dot surface. In the alloy, we identify a pure CdSe nucleus of approximately 1.5 nm, consistent with the predictions of nucleation theory. As the particle grows, S(2-) incorporation increases until the CdSSe reaches approximately 4 nm, where a marked reduction in phenylthiolate content on the nanocrystal is observed by CP-MAS NMR spectroscopy, implying that rapid decomposition of the phenylthiolate arises with subsequent enhanced S(2-) incorporation at the level of the stoichiometry of the reaction (namely approximately 60%). The use of molecular clusters to allow controlled defect ion incorporation can open new pathways to more complex nanomaterials.
Deletion of sphingosine kinase 1 inhibits liver tumorigenesis in diethylnitrosamine-treated mice
Chen, Jinbiao; Qi, Yanfei; Zhao, Yang; Kaczorowski, Dominik; Couttas, Timothy A.; Coleman, Paul R.; Don, Anthony S.; Bertolino, Patrick; Gamble, Jennifer R.; Vadas, Mathew A.; Xia, Pu; McCaughan, Geoffrey W.
2018-01-01
Primary liver cancer is the 3rd leading cause of cancer deaths worldwide with very few effective treatments. Sphingosine kinase 1 (SphK1), a key regulator of sphingolipid metabolites, is over-expressed in human hepatocellular carcinoma (HCC) and our previous studies have shown that SphK1 is important in liver injury. We aimed to explore the role of SphK1 specifically in liver tumorigenesis using the SphK1 knockout (SphK1−/−) mouse. SphK1 deletion significantly reduced the number and the size of DEN-induced liver cancers in mice. Mechanistically, fewer proliferating but more apoptotic and senescent cells were detected in SphK1 deficient tumors compared to WT tumors. There was an increase in sphingosine rather than a decrease in sphingosine 1-phosphate (S1P) in SphK1 deficient tumors. Furthermore, the STAT3-S1PR pathway that has been reported previously to mediate the effect of SphK1 on colorectal cancers was not altered by SphK1 deletion in liver cancer. Instead, c-Myc protein expression was down-regulated by SphK1 deletion. In conclusion, this is the first in vivo evidence that SphK1 contributes to hepatocarcinogenesis. However, the downstream signaling pathways impacting on the development of HCC via SphK1 are organ specific providing further evidence that simply transferring known oncogenic molecular pathway targeting into HCC is not always valid. PMID:29643998
NASA Astrophysics Data System (ADS)
Balaji, V.; Benson, Rusty; Wyman, Bruce; Held, Isaac
2016-10-01
Climate models represent a large variety of processes on a variety of timescales and space scales, a canonical example of multi-physics multi-scale modeling. Current hardware trends, such as Graphical Processing Units (GPUs) and Many Integrated Core (MIC) chips, are based on, at best, marginal increases in clock speed, coupled with vast increases in concurrency, particularly at the fine grain. Multi-physics codes face particular challenges in achieving fine-grained concurrency, as different physics and dynamics components have different computational profiles, and universal solutions are hard to come by. We propose here one approach for multi-physics codes. These codes are typically structured as components interacting via software frameworks. The component structure of a typical Earth system model consists of a hierarchical and recursive tree of components, each representing a different climate process or dynamical system. This recursive structure generally encompasses a modest level of concurrency at the highest level (e.g., atmosphere and ocean on different processor sets) with serial organization underneath. We propose to extend concurrency much further by running more and more lower- and higher-level components in parallel with each other. Each component can further be parallelized on the fine grain, potentially offering a major increase in the scalability of Earth system models. We present here first results from this approach, called coarse-grained component concurrency, or CCC. Within the Geophysical Fluid Dynamics Laboratory (GFDL) Flexible Modeling System (FMS), the atmospheric radiative transfer component has been configured to run in parallel with a composite component consisting of every other atmospheric component, including the atmospheric dynamics and all other atmospheric physics components. We will explore the algorithmic challenges involved in such an approach, and present results from such simulations. Plans to achieve even greater levels of
Synthesis of sphingosine is essential for oxidative stress-induced apoptosis of photoreceptors.
Abrahan, Carolina E; Miranda, Gisela E; Agnolazza, Daniela L; Politi, Luis E; Rotstein, Nora P
2010-02-01
Oxidative stress is involved in inducing apoptosis of photoreceptors in many retinal neurodegenerative diseases. It has been shown that oxidative stress increases in photoreceptors the synthesis of ceramide, a sphingolipid precursor that then activates apoptosis. In several cell types, ceramide is converted by ceramidases to sphingosine (Sph), another apoptosis mediator; hence, this study was undertaken to determine whether Sph participates in triggering photoreceptor apoptosis. Rat retina neurons were incubated with [(3)H]palmitic acid and treated with the oxidant paraquat (PQ) to evaluate Sph synthesis. Sph was added to cultures with or without docosahexaenoic acid (DHA), the major retina polyunsaturated fatty acid and a photoreceptor survival factor, to evaluate apoptosis. Synthesis of Sph and sphingosine-1-phosphate (S1P), a prosurvival signal, were inhibited with alkaline ceramidase or sphingosine kinase inhibitors, respectively, before adding PQ, C(2)-ceramide, or Sph. Apoptosis, mitochondrial membrane polarization, cytochrome c localization, and reactive oxygen species (ROS) production were determined. PQ increased [(3)H]Sph synthesis in photoreceptors and blocking this synthesis by inhibiting alkaline ceramidase decreased PQ-induced apoptosis. Addition of Sph induced photoreceptor apoptosis, increased ROS production, and promoted cytochrome c release from mitochondria. Although DHA prevented this apoptosis, inhibiting Sph conversion to S1P blocked DHA protection. These results suggest that oxidative stress enhances formation of ceramide and its subsequent breakdown to Sph; ceramide and/or Sph would then trigger photoreceptor apoptosis. Preventing Sph synthesis or promoting its phosphorylation to S1P rescued photoreceptors, suggesting that Sph is a mediator of their apoptosis and modulation of Sph metabolism may be crucial for promoting photoreceptor survival.
Cai, Xixi; Yan, Ana; Fu, Nanyan; Wang, Shaoyun
2017-04-10
Schizochytrium protein hydrolysate (SPH) was prepared through stepwise enzymatic hydrolysis by alcalase and flavourzyme sequentially. The proportion of hydrophobic amino acids of SPH was 34.71%. The molecular weight (MW) of SPH was principally concentrated at 180-3000 Da (52.29%). SPH was divided into two fractions by ultrafiltration: SPH-I (MW < 3 kDa) and SPH-II (MW > 3 kDa). Besides showing lipid peroxidation inhibitory activity in vitro, SPH-I exhibited high DPPH and ABTS radicals scavenging activities with IC 50 of 350 μg/mL and 17.5 μg/mL, respectively. In addition, the antioxidant activity of SPH-I was estimated in vivo using the model of acute alcohol-induced liver injury in mice. For the hepatoprotective effects, oral administration of SPH-I at different concentrations (100, 300 mg/kg BW) to the mice subjected to alcohol significantly decreased serum alanine aminotransferase (ALT) and aspartate aminotransferase (AST) activities and hepatic malondialdehyde (MDA) level compared to the untreated mice. Besides, SPH-I could effectively restore the hepatic superoxide dismutase (SOD), catalase (CAT), and glutathione peroxidase (GSH-Px) activities and glutathione (GSH) level. Results suggested that SPH was rich in biopeptides that could be exploited as antioxidant molecules against oxidative stress in human body.
Cai, Xixi; Yan, Ana; Fu, Nanyan; Wang, Shaoyun
2017-01-01
Schizochytrium protein hydrolysate (SPH) was prepared through stepwise enzymatic hydrolysis by alcalase and flavourzyme sequentially. The proportion of hydrophobic amino acids of SPH was 34.71%. The molecular weight (MW) of SPH was principally concentrated at 180–3000 Da (52.29%). SPH was divided into two fractions by ultrafiltration: SPH-I (MW < 3 kDa) and SPH-II (MW > 3 kDa). Besides showing lipid peroxidation inhibitory activity in vitro, SPH-I exhibited high DPPH and ABTS radicals scavenging activities with IC50 of 350 μg/mL and 17.5 μg/mL, respectively. In addition, the antioxidant activity of SPH-I was estimated in vivo using the model of acute alcohol-induced liver injury in mice. For the hepatoprotective effects, oral administration of SPH-I at different concentrations (100, 300 mg/kg BW) to the mice subjected to alcohol significantly decreased serum alanine aminotransferase (ALT) and aspartate aminotransferase (AST) activities and hepatic malondialdehyde (MDA) level compared to the untreated mice. Besides, SPH-I could effectively restore the hepatic superoxide dismutase (SOD), catalase (CAT), and glutathione peroxidase (GSH-Px) activities and glutathione (GSH) level. Results suggested that SPH was rich in biopeptides that could be exploited as antioxidant molecules against oxidative stress in human body. PMID:28394291
Low Density Parity Check Codes: Bandwidth Efficient Channel Coding
NASA Technical Reports Server (NTRS)
Fong, Wai; Lin, Shu; Maki, Gary; Yeh, Pen-Shu
2003-01-01
Low Density Parity Check (LDPC) Codes provide near-Shannon Capacity performance for NASA Missions. These codes have high coding rates R=0.82 and 0.875 with moderate code lengths, n=4096 and 8176. Their decoders have inherently parallel structures which allows for high-speed implementation. Two codes based on Euclidean Geometry (EG) were selected for flight ASIC implementation. These codes are cyclic and quasi-cyclic in nature and therefore have a simple encoder structure. This results in power and size benefits. These codes also have a large minimum distance as much as d,,, = 65 giving them powerful error correcting capabilities and error floors less than lo- BER. This paper will present development of the LDPC flight encoder and decoder, its applications and status.
NASA Technical Reports Server (NTRS)
Hinds, Erold W. (Principal Investigator)
1996-01-01
This report describes the progress made towards the completion of a specific task on error-correcting coding. The proposed research consisted of investigating the use of modulation block codes as the inner code of a concatenated coding system in order to improve the overall space link communications performance. The study proposed to identify and analyze candidate codes that will complement the performance of the overall coding system which uses the interleaved RS (255,223) code as the outer code.
Sphingosine kinase inhibitors: a review of patent literature (2006-2015).
Lynch, Kevin R; Thorpe, S Brandon; Santos, Webster L
2016-12-01
Sphingosine kinase (SphK1 & SphK2) is the sole source of the pleiotropic lipid mediator, sphingosine-1-phosphate (S1P). S1P has been implicated in a variety of diseases such as cancer, Alzheimer's disease, sickle cell disease and fibrosis and thus the biosynthetic route to S1P is a logical target for drug discovery. Areas covered: In this review, the authors consider the SphK inhibitor patent literature from 2006-2016 Q1 with the emphasis on composition of matter utility patents. The Espacenet database was queried with the search term 'sphingosine AND kinase' to identify relevant literature. Expert opinion: Early inhibitor discovery focused on SphK1 with a bias towards oncology indications. Structurally, the reported inhibitors occupy the sphingosine 'J-shaped' binding pocket. The lack of cytotoxicity with improved SphK1 inhibitors raises doubt about the enzyme as an oncology target. SphK2 inhibitors are featured in more recent patent applications. Interestingly, both SphK1 and SphK2 inhibition and gene 'knockout' share opposing effects on circulating S1P levels: SphK1 inhibition/gene ablation decreases, while SphK2 inhibition/gene ablation increases, blood S1P. As understanding of S1P's physiological roles increases and more drug-like SphK inhibitors emerge, inhibiting one or both SphK isotypes could provide unique strategies for treating disease.
Tang, Dalin; Yang, Chun; Geva, Tal; Gaudette, Glenn; del Nido, Pedro J.
2011-01-01
Multi-physics right and left ventricle (RV/LV) fluid-structure interaction (FSI) models were introduced to perform mechanical stress analysis and evaluate the effect of patch materials on RV function. The FSI models included three different patch materials (Dacron scaffold, treated pericardium, and contracting myocardium), two-layer construction, fiber orientation, and active anisotropic material properties. The models were constructed based on cardiac magnetic resonance (CMR) images acquired from a patient with severe RV dilatation and solved by ADINA. Our results indicate that the patch model with contracting myocardium leads to decreased stress level in the patch area, improved RV function and patch area contractility. PMID:21765559
Rate-compatible punctured convolutional codes (RCPC codes) and their applications
NASA Astrophysics Data System (ADS)
Hagenauer, Joachim
1988-04-01
The concept of punctured convolutional codes is extended by punctuating a low-rate 1/N code periodically with period P to obtain a family of codes with rate P/(P + l), where l can be varied between 1 and (N - 1)P. A rate-compatibility restriction on the puncturing tables ensures that all code bits of high rate codes are used by the lower-rate codes. This allows transmission of incremental redundancy in ARQ/FEC (automatic repeat request/forward error correction) schemes and continuous rate variation to change from low to high error protection within a data frame. Families of RCPC codes with rates between 8/9 and 1/4 are given for memories M from 3 to 6 (8 to 64 trellis states) together with the relevant distance spectra. These codes are almost as good as the best known general convolutional codes of the respective rates. It is shown that the same Viterbi decoder can be used for all RCPC codes of the same M. The application of RCPC codes to hybrid ARQ/FEC schemes is discussed for Gaussian and Rayleigh fading channels using channel-state information to optimize throughput.
Rambukwella, Milan; Dass, Amala
2017-10-17
Phenylethanethiol protected nanomolecules such as Au 25 , Au 38 , and Au 144 are widely studied by a broad range of scientists in the community, owing primarily to the availability of simple synthetic protocols. However, synthetic methods are not available for other ligands, such as aromatic thiol and bulky ligands, impeding progress. Here we report the facile synthesis of three distinct nanomolecules, Au 38 (SCH 2 CH 2 Ph) 24 , Au 36 (SPh-tBu) 24 , and Au 30 (S-tBu) 18 , exclusively, starting from a common Au n (glutathione) m (where n and m are number of gold atoms and glutathiolate ligands) starting material upon reaction with HSCH 2 CH 2 Ph, HSPh-tBu, and HStBu, respectively. The systematic synthetic approach involves two steps: (i) synthesis of kinetically controlled Au n (glutathione) m crude nanocluster mixture with 1:4 gold to thiol molar ratio and (ii) thermochemical treatment of the purified nanocluster mixture with excess thiols to obtain thermodynamically stable nanomolecules. Thermochemical reactions with physicochemically different ligands formed highly monodispersed, exclusively three different core-size nanomolecules, suggesting a ligand induced core-size conversion and structural transformation. The purpose of this work is to make available a facile and simple synthetic method for the preparation of Au 38 (SCH 2 CH 2 Ph) 24 , Au 36 (SPh-tBu) 24 , and Au 30 (S-tBu) 18 , to nonspecialists and the broader scientific community. The central idea of simple synthetic method was demonstrated with other ligand systems such as cyclopentanethiol (HSC 5 H 9 ), cyclohexanethiol(HSC 6 H 11 ), para-methylbenzenethiol(pMBT), 1-pentanethiol(HSC 5 H 11 ), 1-hexanethiol(HSC 6 H 13 ), where Au 36 (SC 5 H 9 ) 24 , Au 36 (SC 6 H 11 ) 24 , Au 36 (pMBT) 24 , Au 38 (SC 5 H 11 ) 24 , and Au 38 (SC 6 H 13 ) 24 were obtained, respectively.
NASA Astrophysics Data System (ADS)
Anderson, Kyle R.; Poland, Michael P.
2016-08-01
Estimating rates of magma supply to the world's volcanoes remains one of the most fundamental aims of volcanology. Yet, supply rates can be difficult to estimate even at well-monitored volcanoes, in part because observations are noisy and are usually considered independently rather than as part of a holistic system. In this work we demonstrate a technique for probabilistically estimating time-variable rates of magma supply to a volcano through probabilistic constraint on storage and eruption rates. This approach utilizes Bayesian joint inversion of diverse datasets using predictions from a multiphysical volcano model, and independent prior information derived from previous geophysical, geochemical, and geological studies. The solution to the inverse problem takes the form of a probability density function which takes into account uncertainties in observations and prior information, and which we sample using a Markov chain Monte Carlo algorithm. Applying the technique to Kīlauea Volcano, we develop a model which relates magma flow rates with deformation of the volcano's surface, sulfur dioxide emission rates, lava flow field volumes, and composition of the volcano's basaltic magma. This model accounts for effects and processes mostly neglected in previous supply rate estimates at Kīlauea, including magma compressibility, loss of sulfur to the hydrothermal system, and potential magma storage in the volcano's deep rift zones. We jointly invert data and prior information to estimate rates of supply, storage, and eruption during three recent quasi-steady-state periods at the volcano. Results shed new light on the time-variability of magma supply to Kīlauea, which we find to have increased by 35-100% between 2001 and 2006 (from 0.11-0.17 to 0.18-0.28 km3/yr), before subsequently decreasing to 0.08-0.12 km3/yr by 2012. Changes in supply rate directly impact hazard at the volcano, and were largely responsible for an increase in eruption rate of 60-150% between 2001 and
NASA Astrophysics Data System (ADS)
MahmoodPoorDehkordy, F.; Briggs, M. A.; Day-Lewis, F. D.; Bagtzoglou, A. C.
2017-12-01
Although hyporheic zones are often modeled at the reach scale as homogeneous "boxes" of exchange, heterogeneity caused by variations of pore sizes and connectivity is not uncommon. This heterogeneity leads to the creation of more- and less-mobile zones of hydraulic exchange that influence reactive solute transport processes. Whereas fluid sampling is generally sensitive to more-mobile zones, geoelectrical measurement is sensitive to ionic tracer dynamics in both less- and more-mobile zones. Heterogeneity in pore connectivity leads to a lag between fluid and bulk electrical conductivity (EC) resulting in a hysteresis loop, observed during tracer breakthrough tests, that contains information about the less-mobile porosity attributes of the medium. Here, we present a macro-scale model of solute transport and electrical conduction developed using COMSOL Multiphysics. The model is used to simulate geoelectrical monitoring of ionic transport for bed sediments based on (1) a stochastic sand-and-cobble mixture and (2) a dune feature with strong permeability layering. In both of these disparate sediment types, hysteresis between fluid and bulk EC is observed, and depends in part on fluid flux rate through the model domain. Using the hysteresis loop, the ratio of less-mobile to mobile porosity and mass-transfer coefficient are estimated graphically. The results indicate the presence and significance of less-mobile porosity in the hyporheic zones and demonstrate the capability of the proposed model to detect heterogeneity in flow processes and estimate less-mobile zone parameters.
Amino acid codes in mitochondria as possible clues to primitive codes
NASA Technical Reports Server (NTRS)
Jukes, T. H.
1981-01-01
Differences between mitochondrial codes and the universal code indicate that an evolutionary simplification has taken place, rather than a return to a more primitive code. However, these differences make it evident that the universal code is not the only code possible, and therefore earlier codes may have differed markedly from the previous code. The present universal code is probably a 'frozen accident.' The change in CUN codons from leucine to threonine (Neurospora vs. yeast mitochondria) indicates that neutral or near-neutral changes occurred in the corresponding proteins when this code change took place, caused presumably by a mutation in a tRNA gene.
Soluble soy protein peptic hydrolysate stimulates adipocyte differentiation in 3T3-L1 cells.
Goto, Tsuyoshi; Mori, Ayaka; Nagaoka, Satoshi
2013-08-01
The molecular mechanisms underlying the potential health benefit effects of soybean proteins on obesity-associated metabolic disorders have not been fully clarified. In this study, we investigated the effects of soluble soybean protein peptic hydrolysate (SPH) on adipocyte differentiation by using 3T3-L1 murine preadipocytes. The addition of SPH increased lipid accumulation during adipocyte differentiation. SPH increased the mRNA expression levels of an adipogenic marker gene and decreased that of a preadipocyte marker gene, suggesting that SPH promotes adipocyte differentiation. SPH induced antidiabetic and antiatherogenic adiponectin mRNA expression and secretion. Moreover, SPH increased the mRNA expression levels of insulin-responsive glucose transporter 4 and insulin-stimulated glucose uptake. The expression levels of peroxisome proliferator-activated receptor γ (PPARγ), a key regulator of adipocyte differentiation, during adipocyte differentiation were up-regulated in 3T3-L1 cells treated with SPH, and lipid accumulation during adipocyte differentiation induced by SPH was inhibited in the presence of a PPARγ antagonist. However, SPH did not exhibit PPARγ ligand activity. These findings indicate that SPH stimulates adipocyte differentiation, at least in part, via the up-regulation of PPARγ expression levels. These effects of SPH might be important for the health benefit effects of soybean proteins on obesity-associated metabolic disorders. © 2013 WILEY-VCH Verlag GmbH & Co. KGaA, Weinheim.
Analysis of quantum error-correcting codes: Symplectic lattice codes and toric codes
NASA Astrophysics Data System (ADS)
Harrington, James William
Quantum information theory is concerned with identifying how quantum mechanical resources (such as entangled quantum states) can be utilized for a number of information processing tasks, including data storage, computation, communication, and cryptography. Efficient quantum algorithms and protocols have been developed for performing some tasks (e.g. , factoring large numbers, securely communicating over a public channel, and simulating quantum mechanical systems) that appear to be very difficult with just classical resources. In addition to identifying the separation between classical and quantum computational power, much of the theoretical focus in this field over the last decade has been concerned with finding novel ways of encoding quantum information that are robust against errors, which is an important step toward building practical quantum information processing devices. In this thesis I present some results on the quantum error-correcting properties of oscillator codes (also described as symplectic lattice codes) and toric codes. Any harmonic oscillator system (such as a mode of light) can be encoded with quantum information via symplectic lattice codes that are robust against shifts in the system's continuous quantum variables. I show the existence of lattice codes whose achievable rates match the one-shot coherent information over the Gaussian quantum channel. Also, I construct a family of symplectic self-dual lattices and search for optimal encodings of quantum information distributed between several oscillators. Toric codes provide encodings of quantum information into two-dimensional spin lattices that are robust against local clusters of errors and which require only local quantum operations for error correction. Numerical simulations of this system under various error models provide a calculation of the accuracy threshold for quantum memory using toric codes, which can be related to phase transitions in certain condensed matter models. I also present
Smoothed Particle Hydrodynamics Simulations of Ultrarelativistic Shocks with Artificial Viscosity
NASA Astrophysics Data System (ADS)
Siegler, S.; Riffert, H.
2000-03-01
We present a fully Lagrangian conservation form of the general relativistic hydrodynamic equations for perfect fluids with artificial viscosity in a given arbitrary background spacetime. This conservation formulation is achieved by choosing suitable Lagrangian time evolution variables, from which the generic fluid variables of rest-mass density, 3-velocity, and thermodynamic pressure have to be determined. We present the corresponding equations for an ideal gas and show the existence and uniqueness of the solution. On the basis of the Lagrangian formulation we have developed a three-dimensional general relativistic smoothed particle hydrodynamics (SPH) code using the standard SPH formalism as known from nonrelativistic fluid dynamics. One-dimensional simulations of a shock tube and a wall shock are presented together with a two-dimensional test calculation of an inclined shock tube. With our method we can model ultrarelativistic fluid flows including shocks with Lorentz factors of even 1000.
Number of minimum-weight code words in a product code
NASA Technical Reports Server (NTRS)
Miller, R. L.
1978-01-01
Consideration is given to the number of minimum-weight code words in a product code. The code is considered as a tensor product of linear codes over a finite field. Complete theorems and proofs are presented.
Resolved granular debris-flow simulations with a coupled SPH-DCDEM model
NASA Astrophysics Data System (ADS)
Birjukovs Canelas, Ricardo; Domínguez, José M.; Crespo, Alejandro J. C.; Gómez-Gesteira, Moncho; Ferreira, Rui M. L.
2016-04-01
Debris flows represent some of the most relevant phenomena in geomorphological events. Due to the potential destructiveness of such flows, they are the target of a vast amount of research (Takahashi, 2007 and references therein). A complete description of the internal processes of a debris-flow is however still an elusive achievement, explained by the difficulty of accurately measuring important quantities in these flows and developing a comprehensive, generalized theoretical framework capable of describing them. This work addresses the need for a numerical model applicable to granular-fluid mixtures featuring high spatial and temporal resolution, thus capable of resolving the motion of individual particles, including all interparticle contacts. This corresponds to a brute-force approach: by applying simple interaction laws at local scales the macro-scale properties of the flow should be recovered by upscaling. This methodology effectively bypasses the complexity of modelling the intermediate scales by resolving them directly. The only caveat is the need of high performance computing, a demanding but engaging research challenge. The DualSPHysics meshless numerical implementation, based on Smoothed Particle Hydrodynamics (SPH), is expanded with a Distributed Contact Discrete Element Method (DCDEM) in order to explicitly solve the fluid and the solid phase. The model numerically solves the Navier-Stokes and continuity equations for the liquid phase and Newton's motion equations for solid bodies. The interactions between solids are modelled with classical DEM approaches (Kruggel-Emden et al, 2007). Among other validation tests, an experimental set-up for stony debris flows in a slit check dam is reproduced numerically, where solid material is introduced trough a hopper assuring a constant solid discharge for the considered time interval. With each sediment particle undergoing tens of possible contacts, several thousand time-evolving contacts are efficiently treated
NASA Technical Reports Server (NTRS)
Pollara, Fabrizio; Hamkins, Jon; Dolinar, Sam; Andrews, Ken; Divsalar, Dariush
2006-01-01
This viewgraph presentation reviews uplink coding. The purpose and goals of the briefing are (1) Show a plan for using uplink coding and describe benefits (2) Define possible solutions and their applicability to different types of uplink, including emergency uplink (3) Concur with our conclusions so we can embark on a plan to use proposed uplink system (4) Identify the need for the development of appropriate technology and infusion in the DSN (5) Gain advocacy to implement uplink coding in flight projects Action Item EMB04-1-14 -- Show a plan for using uplink coding, including showing where it is useful or not (include discussion of emergency uplink coding).
NASA Astrophysics Data System (ADS)
Sivanesapillai, Rakulan; Falkner, Nadine; Hartmaier, Alexander; Steeb, Holger
2016-09-01
We present a conservative smoothed particle hydrodynamics (SPH) model to study the flow of multiple, immiscible fluid phases in porous media using direct pore-scale simulations. Particular focus is put on continuously tracking the evolution of interfacial areas, which are considered to be important morphological quantities affecting multiphase transport in porous media. In addition to solving the Navier-Stokes equations, the model accounts for the effects of capillarity at interfaces and contact lines. This is done by means of incorporating the governing interfacial mass and momentum balances using the continuum surface force (CSF) method, thus rendering model calibration routines unnecessary and minimizing the set of constitutive and kinematic assumptions. We address the application of boundary conditions at rigid solid surfaces and study the predictive capability of the model as well as optimal choices for numerical parameters using an extensive model validation procedure. We demonstrate the applicability of the model to simulate multiphase flows involving partial wettability, dynamic effects, large density ratios (up to 1000), large viscosity ratios (up to 100), as well as fragmentation and coalescence of fluid phases. The model is used to study the evolution of fluid-fluid interfacial areas during saturation-controlled primary drainage and main imbibition of heterogeneous pore spaces at low capillary numbers. A variety of pore-scale effects, such as wetting phase entrapment and fragmentation due to snap-off, are observed. Specific fluid-fluid interfacial area is observed to monotonically increase during primary drainage and hysteretic effects are apparent during main imbibition.
Supermassive Black Holes and their Host Spheroids III. The Mbh-nsph Correlation
NASA Astrophysics Data System (ADS)
Savorgnan, Giulia A. D.
2016-04-01
The Sérsic {R}1/n model is the best approximation known to date for describing the light distribution of stellar spheroidal and disk components, with the Sérsic index n providing a direct measure of the central radial concentration of stars. The Sérsic index of a galaxy’s spheroidal component, nsph, has been shown to tightly correlate with the mass of the central supermassive black hole, MBH. The {M}{BH}{--}{n}{sph} correlation is also expected from other two well known scaling relations involving the spheroid luminosity, Lsph: the {L}{sph}{--}{n}{sph} and the {M}{BH}{--}{L}{sph}. Obtaining an accurate estimate of the spheroid Sérsic index requires a careful modeling of a galaxy’s light distribution and some studies have failed to recover a statistically significant {M}{BH}{--}{n}{sph} correlation. With the aim of re-investigating the {M}{BH}{--}{n}{sph} and other black hole mass scaling relations, we performed a detailed (I.e., bulge, disks, bars, spiral arms, rings, halo, nucleus, etc.) decomposition of 66 galaxies, with directly measured black hole masses, that had been imaged at 3.6 μm with Spitzer. In this paper, the third of this series, we present an analysis of the {L}{sph}{--}{n}{sph} and {M}{BH}{--}{n}{sph} diagrams. While early-type (elliptical+lenticular) and late-type (spiral) galaxies split into two separate relations in the {L}{sph}{--}{n}{sph} and {M}{BH}{--}{L}{sph} diagrams, they reunite into a single {M}{BH}\\propto {n}{sph}3.39+/- 0.15 sequence with relatively small intrinsic scatter (ɛ ≃ 0.25 {dex}). The black hole mass appears to be closely related to the spheroid central concentration of stars, which mirrors the inner gradient of the spheroid gravitational potential.
A new class of accurate, mesh-free hydrodynamic simulation methods
NASA Astrophysics Data System (ADS)
Hopkins, Philip F.
2015-06-01
We present two new Lagrangian methods for hydrodynamics, in a systematic comparison with moving-mesh, smoothed particle hydrodynamics (SPH), and stationary (non-moving) grid methods. The new methods are designed to simultaneously capture advantages of both SPH and grid-based/adaptive mesh refinement (AMR) schemes. They are based on a kernel discretization of the volume coupled to a high-order matrix gradient estimator and a Riemann solver acting over the volume `overlap'. We implement and test a parallel, second-order version of the method with self-gravity and cosmological integration, in the code GIZMO:1 this maintains exact mass, energy and momentum conservation; exhibits superior angular momentum conservation compared to all other methods we study; does not require `artificial diffusion' terms; and allows the fluid elements to move with the flow, so resolution is automatically adaptive. We consider a large suite of test problems, and find that on all problems the new methods appear competitive with moving-mesh schemes, with some advantages (particularly in angular momentum conservation), at the cost of enhanced noise. The new methods have many advantages versus SPH: proper convergence, good capturing of fluid-mixing instabilities, dramatically reduced `particle noise' and numerical viscosity, more accurate sub-sonic flow evolution, and sharp shock-capturing. Advantages versus non-moving meshes include: automatic adaptivity, dramatically reduced advection errors and numerical overmixing, velocity-independent errors, accurate coupling to gravity, good angular momentum conservation and elimination of `grid alignment' effects. We can, for example, follow hundreds of orbits of gaseous discs, while AMR and SPH methods break down in a few orbits. However, fixed meshes minimize `grid noise'. These differences are important for a range of astrophysical problems.
Accurate, meshless methods for magnetohydrodynamics
NASA Astrophysics Data System (ADS)
Hopkins, Philip F.; Raives, Matthias J.
2016-01-01
Recently, we explored new meshless finite-volume Lagrangian methods for hydrodynamics: the `meshless finite mass' (MFM) and `meshless finite volume' (MFV) methods; these capture advantages of both smoothed particle hydrodynamics (SPH) and adaptive mesh refinement (AMR) schemes. We extend these to include ideal magnetohydrodynamics (MHD). The MHD equations are second-order consistent and conservative. We augment these with a divergence-cleaning scheme, which maintains nabla \\cdot B≈ 0. We implement these in the code GIZMO, together with state-of-the-art SPH MHD. We consider a large test suite, and show that on all problems the new methods are competitive with AMR using constrained transport (CT) to ensure nabla \\cdot B=0. They correctly capture the growth/structure of the magnetorotational instability, MHD turbulence, and launching of magnetic jets, in some cases converging more rapidly than state-of-the-art AMR. Compared to SPH, the MFM/MFV methods exhibit convergence at fixed neighbour number, sharp shock-capturing, and dramatically reduced noise, divergence errors, and diffusion. Still, `modern' SPH can handle most test problems, at the cost of larger kernels and `by hand' adjustment of artificial diffusion. Compared to non-moving meshes, the new methods exhibit enhanced `grid noise' but reduced advection errors and diffusion, easily include self-gravity, and feature velocity-independent errors and superior angular momentum conservation. They converge more slowly on some problems (smooth, slow-moving flows), but more rapidly on others (involving advection/rotation). In all cases, we show divergence control beyond the Powell 8-wave approach is necessary, or all methods can converge to unphysical answers even at high resolution.
Multiple component codes based generalized LDPC codes for high-speed optical transport.
Djordjevic, Ivan B; Wang, Ting
2014-07-14
A class of generalized low-density parity-check (GLDPC) codes suitable for optical communications is proposed, which consists of multiple local codes. It is shown that Hamming, BCH, and Reed-Muller codes can be used as local codes, and that the maximum a posteriori probability (MAP) decoding of these local codes by Ashikhmin-Lytsin algorithm is feasible in terms of complexity and performance. We demonstrate that record coding gains can be obtained from properly designed GLDPC codes, derived from multiple component codes. We then show that several recently proposed classes of LDPC codes such as convolutional and spatially-coupled codes can be described using the concept of GLDPC coding, which indicates that the GLDPC coding can be used as a unified platform for advanced FEC enabling ultra-high speed optical transport. The proposed class of GLDPC codes is also suitable for code-rate adaption, to adjust the error correction strength depending on the optical channel conditions.
Intracellular sphingosine releases calcium from lysosomes.
Höglinger, Doris; Haberkant, Per; Aguilera-Romero, Auxiliadora; Riezman, Howard; Porter, Forbes D; Platt, Frances M; Galione, Antony; Schultz, Carsten
2015-11-27
To elucidate new functions of sphingosine (Sph), we demonstrate that the spontaneous elevation of intracellular Sph levels via caged Sph leads to a significant and transient calcium release from acidic stores that is independent of sphingosine 1-phosphate, extracellular and ER calcium levels. This photo-induced Sph-driven calcium release requires the two-pore channel 1 (TPC1) residing on endosomes and lysosomes. Further, uncaging of Sph leads to the translocation of the autophagy-relevant transcription factor EB (TFEB) to the nucleus specifically after lysosomal calcium release. We confirm that Sph accumulates in late endosomes and lysosomes of cells derived from Niemann-Pick disease type C (NPC) patients and demonstrate a greatly reduced calcium release upon Sph uncaging. We conclude that sphingosine is a positive regulator of calcium release from acidic stores and that understanding the interplay between Sph homeostasis, calcium signaling and autophagy will be crucial in developing new therapies for lipid storage disorders such as NPC.
ERIC Educational Resources Information Center
New Mexico Univ., Albuquerque. American Indian Law Center.
The Model Children's Code was developed to provide a legally correct model code that American Indian tribes can use to enact children's codes that fulfill their legal, cultural and economic needs. Code sections cover the court system, jurisdiction, juvenile offender procedures, minor-in-need-of-care, and termination. Almost every Code section is…