WorldWideScience

Sample records for transport sweep algorithms

  1. Analysis of Massively Parallel Discrete-Ordinates Transport Sweep Algorithms with Collisions

    International Nuclear Information System (INIS)

    Bailey, T.S.; Falgout, R.D.

    2008-01-01

    We present theoretical scaling models for a variety of discrete-ordinates sweep algorithms. In these models, we pay particular attention to the way each algorithm handles collisions. A collision is defined as a processor having multiple angles with ready to be swept during one stage of the sweep. The models also take into account how subdomains are assigned to processors and how angles are grouped during the sweep. We describe a data driven algorithm that resolves collisions efficiently during the sweep as well as other algorithms that have been designed to avoid collisions completely. Our models are validated using the ARGES and AMTRAN transport codes. We then use the models to study and predict scaling trends in all of the sweep algorithms

  2. Provably optimal parallel transport sweeps on regular grids

    International Nuclear Information System (INIS)

    Adams, M. P.; Adams, M. L.; Hawkins, W. D.; Smith, T.; Rauchwerger, L.; Amato, N. M.; Bailey, T. S.; Falgout, R. D.

    2013-01-01

    We have found provably optimal algorithms for full-domain discrete-ordinate transport sweeps on regular grids in 3D Cartesian geometry. We describe these algorithms and sketch a 'proof that they always execute the full eight-octant sweep in the minimum possible number of stages for a given P x x P y x P z partitioning. Computational results demonstrate that our optimal scheduling algorithms execute sweeps in the minimum possible stage count. Observed parallel efficiencies agree well with our performance model. An older version of our PDT transport code achieves almost 80% parallel efficiency on 131,072 cores, on a weak-scaling problem with only one energy group, 80 directions, and 4096 cells/core. A newer version is less efficient at present-we are still improving its implementation - but achieves almost 60% parallel efficiency on 393,216 cores. These results conclusively demonstrate that sweeps can perform with high efficiency on core counts approaching 10 6 . (authors)

  3. Provably optimal parallel transport sweeps on regular grids

    Energy Technology Data Exchange (ETDEWEB)

    Adams, M. P.; Adams, M. L.; Hawkins, W. D. [Dept. of Nuclear Engineering, Texas A and M University, 3133 TAMU, College Station, TX 77843-3133 (United States); Smith, T.; Rauchwerger, L.; Amato, N. M. [Dept. of Computer Science and Engineering, Texas A and M University, 3133 TAMU, College Station, TX 77843-3133 (United States); Bailey, T. S.; Falgout, R. D. [Lawrence Livermore National Laboratory (United States)

    2013-07-01

    We have found provably optimal algorithms for full-domain discrete-ordinate transport sweeps on regular grids in 3D Cartesian geometry. We describe these algorithms and sketch a 'proof that they always execute the full eight-octant sweep in the minimum possible number of stages for a given P{sub x} x P{sub y} x P{sub z} partitioning. Computational results demonstrate that our optimal scheduling algorithms execute sweeps in the minimum possible stage count. Observed parallel efficiencies agree well with our performance model. An older version of our PDT transport code achieves almost 80% parallel efficiency on 131,072 cores, on a weak-scaling problem with only one energy group, 80 directions, and 4096 cells/core. A newer version is less efficient at present-we are still improving its implementation - but achieves almost 60% parallel efficiency on 393,216 cores. These results conclusively demonstrate that sweeps can perform with high efficiency on core counts approaching 10{sup 6}. (authors)

  4. Parallel Sn Sweeps on Unstructured Grids: Algorithms for Prioritization, Grid Partitioning, and Cycle Detection

    International Nuclear Information System (INIS)

    Plimpton, Steven J.; Hendrickson, Bruce; Burns, Shawn P.; McLendon, William III; Rauchwerger, Lawrence

    2005-01-01

    The method of discrete ordinates is commonly used to solve the Boltzmann transport equation. The solution in each ordinate direction is most efficiently computed by sweeping the radiation flux across the computational grid. For unstructured grids this poses many challenges, particularly when implemented on distributed-memory parallel machines where the grid geometry is spread across processors. We present several algorithms relevant to this approach: (a) an asynchronous message-passing algorithm that performs sweeps simultaneously in multiple ordinate directions, (b) a simple geometric heuristic to prioritize the computational tasks that a processor works on, (c) a partitioning algorithm that creates columnar-style decompositions for unstructured grids, and (d) an algorithm for detecting and eliminating cycles that sometimes exist in unstructured grids and can prevent sweeps from successfully completing. Algorithms (a) and (d) are fully parallel; algorithms (b) and (c) can be used in conjunction with (a) to achieve higher parallel efficiencies. We describe our message-passing implementations of these algorithms within a radiation transport package. Performance and scalability results are given for unstructured grids with up to 3 million elements (500 million unknowns) running on thousands of processors of Sandia National Laboratories' Intel Tflops machine and DEC-Alpha CPlant cluster

  5. An Algorithm for Parallel Sn Sweeps on Unstructured Meshes

    International Nuclear Information System (INIS)

    Pautz, Shawn D.

    2002-01-01

    A new algorithm for performing parallel S n sweeps on unstructured meshes is developed. The algorithm uses a low-complexity list ordering heuristic to determine a sweep ordering on any partitioned mesh. For typical problems and with 'normal' mesh partitionings, nearly linear speedups on up to 126 processors are observed. This is an important and desirable result, since although analyses of structured meshes indicate that parallel sweeps will not scale with normal partitioning approaches, no severe asymptotic degradation in the parallel efficiency is observed with modest (≤100) levels of parallelism. This result is a fundamental step in the development of efficient parallel S n methods

  6. Alternating direction transport sweeps for linear discontinuous SN method

    International Nuclear Information System (INIS)

    Yavuz, M.; Aykanat, C.

    1993-01-01

    The performance of Alternating Direction Transport Sweep (ADTS) method is investigated for spatially differenced Linear Discontinuous S N (LD-S N ) problems on a MIMD multicomputer, Intel IPSC/2. The method consists of dividing a transport problem spatially into sub-problems, assigning each sub-problem to a separate processor. Then, the problem is solved by performing transport sweeps iterating on the scattering source and interface fluxes between the sub-problems. In each processor, the order of transport sweeps is scheduled such that a processor completing its computation in a quadrant of a transport sweep is able to use the most recent information (exiting fluxes of neighboring processor) as its incoming fluxes to start the next quadrant calculation. Implementation of this method on the Intel IPSC/2 multicomputer displays significant speedups over the one-processor method. Also, the performance of the method is compared with those reported previously for the Diamond Differenced S N (DD-S N ) method. Our experimental experience illustrates that the parallel performance of both the ADTS LD- and DD-S N methods is the same. (orig.)

  7. Fast algorithms for transport models. Final report

    International Nuclear Information System (INIS)

    Manteuffel, T.A.

    1994-01-01

    This project has developed a multigrid in space algorithm for the solution of the S N equations with isotropic scattering in slab geometry. The algorithm was developed for the Modified Linear Discontinuous (MLD) discretization in space which is accurate in the thick diffusion limit. It uses a red/black two-cell μ-line relaxation. This relaxation solves for all angles on two adjacent spatial cells simultaneously. It takes advantage of the rank-one property of the coupling between angles and can perform this inversion in O(N) operations. A version of the multigrid in space algorithm was programmed on the Thinking Machines Inc. CM-200 located at LANL. It was discovered that on the CM-200 a block Jacobi type iteration was more efficient than the block red/black iteration. Given sufficient processors all two-cell block inversions can be carried out simultaneously with a small number of parallel steps. The bottleneck is the need for sums of N values, where N is the number of discrete angles, each from a different processor. These are carried out by machine intrinsic functions and are well optimized. The overall algorithm has computational complexity O(log(M)), where M is the number of spatial cells. The algorithm is very efficient and represents the state-of-the-art for isotropic problems in slab geometry. For anisotropic scattering in slab geometry, a multilevel in angle algorithm was developed. A parallel version of the multilevel in angle algorithm has also been developed. Upon first glance, the shifted transport sweep has limited parallelism. Once the right-hand-side has been computed, the sweep is completely parallel in angle, becoming N uncoupled initial value ODE's. The author has developed a cyclic reduction algorithm that renders it parallel with complexity O(log(M)). The multilevel in angle algorithm visits log(N) levels, where shifted transport sweeps are performed. The overall complexity is O(log(N)log(M))

  8. Parallel Implementation and Scaling of an Adaptive Mesh Discrete Ordinates Algorithm for Transport

    International Nuclear Information System (INIS)

    Howell, L H

    2004-01-01

    Block-structured adaptive mesh refinement (AMR) uses a mesh structure built up out of locally-uniform rectangular grids. In the BoxLib parallel framework used by the Raptor code, each processor operates on one or more of these grids at each refinement level. The decomposition of the mesh into grids and the distribution of these grids among processors may change every few timesteps as a calculation proceeds. Finer grids use smaller timesteps than coarser grids, requiring additional work to keep the system synchronized and ensure conservation between different refinement levels. In a paper for NECDC 2002 I presented preliminary results on implementation of parallel transport sweeps on the AMR mesh, conjugate gradient acceleration, accuracy of the AMR solution, and scalar speedup of the AMR algorithm compared to a uniform fully-refined mesh. This paper continues with a more in-depth examination of the parallel scaling properties of the scheme, both in single-level and multi-level calculations. Both sweeping and setup costs are considered. The algorithm scales with acceptable performance to several hundred processors. Trends suggest, however, that this is the limit for efficient calculations with traditional transport sweeps, and that modifications to the sweep algorithm will be increasingly needed as job sizes in the thousands of processors become common

  9. An Adaptive Sweep-Circle Spatial Clustering Algorithm Based on Gestalt

    Directory of Open Access Journals (Sweden)

    Qingming Zhan

    2017-08-01

    Full Text Available An adaptive spatial clustering (ASC algorithm is proposed in this present study, which employs sweep-circle techniques and a dynamic threshold setting based on the Gestalt theory to detect spatial clusters. The proposed algorithm can automatically discover clusters in one pass, rather than through the modification of the initial model (for example, a minimal spanning tree, Delaunay triangulation, or Voronoi diagram. It can quickly identify arbitrarily-shaped clusters while adapting efficiently to non-homogeneous density characteristics of spatial data, without the need for prior knowledge or parameters. The proposed algorithm is also ideal for use in data streaming technology with dynamic characteristics flowing in the form of spatial clustering in large data sets.

  10. Cache Oblivious Distribution Sweeping

    DEFF Research Database (Denmark)

    Brodal, G.S.; Fagerberg, R.

    2002-01-01

    We adapt the distribution sweeping method to the cache oblivious model. Distribution sweeping is the name used for a general approach for divide-and-conquer algorithms where the combination of solved subproblems can be viewed as a merging process of streams. We demonstrate by a series of algorith...

  11. Solution algorithms for a PN-1 - Equivalent SN angular discretization of the transport equation in one-dimensional spherical coordinates

    International Nuclear Information System (INIS)

    Warsa, J. S.; Morel, J. E.

    2007-01-01

    Angular discretizations of the S N transport equation in curvilinear coordinate systems may result in a streaming-plus-removal operator that is dense in the angular variable or that is not lower-triangular. We investigate numerical solution algorithms for such angular discretizations using relationships given by Chandrasekhar to compute the angular derivatives in the one-dimensional S N transport equation in spherical coordinates with Gauss quadrature. This discretization makes the S N transport equation P N-1 - equivalent, but it also makes the sweep operator dense at every spatial point because the N angular derivatives are expressed in terms of the N angular fluxes. To avoid having to invert the sweep operator directly, we must work with the angular fluxes to solve the equations iteratively. We show how we can use approximations to the sweep operator to precondition the full P N-1 equivalent S N equations. We show that these pre-conditioners affect the operator enough such that convergence of a Krylov iterative method improves. (authors)

  12. Fast grid layout algorithm for biological networks with sweep calculation.

    Science.gov (United States)

    Kojima, Kaname; Nagasaki, Masao; Miyano, Satoru

    2008-06-15

    Properly drawn biological networks are of great help in the comprehension of their characteristics. The quality of the layouts for retrieved biological networks is critical for pathway databases. However, since it is unrealistic to manually draw biological networks for every retrieval, automatic drawing algorithms are essential. Grid layout algorithms handle various biological properties such as aligning vertices having the same attributes and complicated positional constraints according to their subcellular localizations; thus, they succeed in providing biologically comprehensible layouts. However, existing grid layout algorithms are not suitable for real-time drawing, which is one of requisites for applications to pathway databases, due to their high-computational cost. In addition, they do not consider edge directions and their resulting layouts lack traceability for biochemical reactions and gene regulations, which are the most important features in biological networks. We devise a new calculation method termed sweep calculation and reduce the time complexity of the current grid layout algorithms through its encoding and decoding processes. We conduct practical experiments by using 95 pathway models of various sizes from TRANSPATH and show that our new grid layout algorithm is much faster than existing grid layout algorithms. For the cost function, we introduce a new component that penalizes undesirable edge directions to avoid the lack of traceability in pathways due to the differences in direction between in-edges and out-edges of each vertex. Java implementations of our layout algorithms are available in Cell Illustrator. masao@ims.u-tokyo.ac.jp Supplementary data are available at Bioinformatics online.

  13. Hybrid massively parallel fast sweeping method for static Hamilton–Jacobi equations

    Energy Technology Data Exchange (ETDEWEB)

    Detrixhe, Miles, E-mail: mdetrixhe@engineering.ucsb.edu [Department of Mechanical Engineering (United States); University of California Santa Barbara, Santa Barbara, CA, 93106 (United States); Gibou, Frédéric, E-mail: fgibou@engineering.ucsb.edu [Department of Mechanical Engineering (United States); University of California Santa Barbara, Santa Barbara, CA, 93106 (United States); Department of Computer Science (United States); Department of Mathematics (United States)

    2016-10-01

    The fast sweeping method is a popular algorithm for solving a variety of static Hamilton–Jacobi equations. Fast sweeping algorithms for parallel computing have been developed, but are severely limited. In this work, we present a multilevel, hybrid parallel algorithm that combines the desirable traits of two distinct parallel methods. The fine and coarse grained components of the algorithm take advantage of heterogeneous computer architecture common in high performance computing facilities. We present the algorithm and demonstrate its effectiveness on a set of example problems including optimal control, dynamic games, and seismic wave propagation. We give results for convergence, parallel scaling, and show state-of-the-art speedup values for the fast sweeping method.

  14. Hybrid massively parallel fast sweeping method for static Hamilton–Jacobi equations

    International Nuclear Information System (INIS)

    Detrixhe, Miles; Gibou, Frédéric

    2016-01-01

    The fast sweeping method is a popular algorithm for solving a variety of static Hamilton–Jacobi equations. Fast sweeping algorithms for parallel computing have been developed, but are severely limited. In this work, we present a multilevel, hybrid parallel algorithm that combines the desirable traits of two distinct parallel methods. The fine and coarse grained components of the algorithm take advantage of heterogeneous computer architecture common in high performance computing facilities. We present the algorithm and demonstrate its effectiveness on a set of example problems including optimal control, dynamic games, and seismic wave propagation. We give results for convergence, parallel scaling, and show state-of-the-art speedup values for the fast sweeping method.

  15. A Compositional Sweep-Line State Space Exploration Method

    DEFF Research Database (Denmark)

    Kristensen, Lars Michael; Mailund, Thomas

    2002-01-01

    State space exploration is a main approach to verification of finite-state systems. The sweep-line method exploits a certain kind of progress present in many systems to reduce peak memory usage during state space exploration. We present a new sweep-line algorithm for a compositional setting where...

  16. Interactions between oxygen permeation and homogeneous-phase fuel conversion on the sweep side of an ion transport membrane

    KAUST Repository

    Hong, Jongsup

    2013-02-01

    The interactions between oxygen permeation and homogeneous fuel oxidation reactions on the sweep side of an ion transport membrane (ITM) are examined using a comprehensive model, which couples the dependency of the oxygen permeation rate on the membrane surface conditions and detailed chemistry and transport in the vicinity of the membrane. We assume that the membrane surface is not catalytic to hydrocarbon or syngas oxidation. Results show that increasing the sweep gas inlet temperature and fuel concentration enhances oxygen permeation substantially. This is accomplished through promoting oxidation reactions (oxygen consumption) and the transport of the products and reaction heat towards the membrane, which lowers the oxygen concentration and increases the gas temperature near the membrane. Faster reactions at higher fuel concentration and higher inlet gas temperature support substantial fuel conversion and lead to a higher oxygen permeation flux without the contribution of surface catalytic activity. Beyond a certain maximum in the fuel concentration, extensive heat loss to the membrane (and feed side) reduces the oxidation kinetic rates and limits oxygen permeation as the reaction front reaches the membrane. The sweep gas flow rate and channel height have moderate impacts on oxygen permeation and fuel conversion due to the residence time requirements for the chemical reactions and the location of the reaction zone relative to the membrane surface. © 2012 Elsevier B.V.

  17. Scalable parallel prefix solvers for discrete ordinates transport

    International Nuclear Information System (INIS)

    Pautz, S.; Pandya, T.; Adams, M.

    2009-01-01

    The well-known 'sweep' algorithm for inverting the streaming-plus-collision term in first-order deterministic radiation transport calculations has some desirable numerical properties. However, it suffers from parallel scaling issues caused by a lack of concurrency. The maximum degree of concurrency, and thus the maximum parallelism, grows more slowly than the problem size for sweeps-based solvers. We investigate a new class of parallel algorithms that involves recasting the streaming-plus-collision problem in prefix form and solving via cyclic reduction. This method, although computationally more expensive at low levels of parallelism than the sweep algorithm, offers better theoretical scalability properties. Previous work has demonstrated this approach for one-dimensional calculations; we show how to extend it to multidimensional calculations. Notably, for multiple dimensions it appears that this approach is limited to long-characteristics discretizations; other discretizations cannot be cast in prefix form. We implement two variants of the algorithm within the radlib/SCEPTRE transport code library at Sandia National Laboratories and show results on two different massively parallel systems. Both the 'forward' and 'symmetric' solvers behave similarly, scaling well to larger degrees of parallelism then sweeps-based solvers. We do observe some issues at the highest levels of parallelism (relative to the system size) and discuss possible causes. We conclude that this approach shows good potential for future parallel systems, but the parallel scalability will depend heavily on the architecture of the communication networks of these systems. (authors)

  18. Lock-free parallel and concurrent garbage collection by mark&sweep

    NARCIS (Netherlands)

    Gao, H.; Groote, J. F.; Hesselink, W. H.

    2007-01-01

    This paper presents a lock-free algorithm for mark&sweep garbage collection (GC) in a realistic model using synchronization primitives load-linked/store-conditional (LL/SC) or compare-and-swap (CAS) offered by machine arch i lectures. The algorithm is concurrent in the sense that garbage collection

  19. A convergence analysis for a sweeping preconditioner for block tridiagonal systems of linear equations

    KAUST Repository

    Bagci, Hakan; Pasciak, Joseph E.; Sirenko, Kostyantyn

    2014-01-01

    We study sweeping preconditioners for symmetric and positive definite block tridiagonal systems of linear equations. The algorithm provides an approximate inverse that can be used directly or in a preconditioned iterative scheme. These algorithms are based on replacing the Schur complements appearing in a block Gaussian elimination direct solve by hierarchical matrix approximations with reduced off-diagonal ranks. This involves developing low rank hierarchical approximations to inverses. We first provide a convergence analysis for the algorithm for reduced rank hierarchical inverse approximation. These results are then used to prove convergence and preconditioning estimates for the resulting sweeping preconditioner.

  20. A convergence analysis for a sweeping preconditioner for block tridiagonal systems of linear equations

    KAUST Repository

    Bagci, Hakan

    2014-11-11

    We study sweeping preconditioners for symmetric and positive definite block tridiagonal systems of linear equations. The algorithm provides an approximate inverse that can be used directly or in a preconditioned iterative scheme. These algorithms are based on replacing the Schur complements appearing in a block Gaussian elimination direct solve by hierarchical matrix approximations with reduced off-diagonal ranks. This involves developing low rank hierarchical approximations to inverses. We first provide a convergence analysis for the algorithm for reduced rank hierarchical inverse approximation. These results are then used to prove convergence and preconditioning estimates for the resulting sweeping preconditioner.

  1. Characterization of Residuals Collected from Street Sweeping Operations

    Science.gov (United States)

    2018-02-01

    Street sweeping is a routine roadway maintenance activity conducted by the Virginia Department of Transportation (VDOT). It also provides an added benefit as a non-structural stormwater best management practice implemented by VDOT to meet total maxim...

  2. Sweeping the State Space

    DEFF Research Database (Denmark)

    Mailund, Thomas

    The thesis describes the sweep-line method, a newly developed reduction method for alleviating the state explosion problem inherent in explicit-state state space exploration. The basic idea underlying the sweep-line method is, when calculating the state space, to recognise and delete states...... that are not reachable from the currently unprocessed states. Intuitively we drag a sweep-line through the state space with the invariant that all states behind the sweep-line have been processed and are unreachable from the states in front of the sweep-line. When calculating the state space of a system we iteratively...

  3. Design and optimization of a bend-and-sweep compliant mechanism

    International Nuclear Information System (INIS)

    Tummala, Y; Frecker, M I; Wissa, A A; Hubbard Jr, J E

    2013-01-01

    A novel contact aided compliant mechanism called bend-and-sweep compliant mechanism is presented in this paper. This mechanism has nonlinear stiffness properties in two orthogonal directions. An angled compliant joint (ACJ) is the fundamental element of this mechanism. Geometric parameters of ACJs determine the stiffness of the compliant mechanism. This paper presents the design and optimization of bend-and-sweep compliant mechanism. A multi-objective optimization problem was formulated for design optimization of the bend-and-sweep compliant mechanism. The objectives of the optimization problem were to maximize or minimize the bending and sweep displacements, depending on the situation, while minimizing the von Mises stress and mass of each mechanism. This optimization problem was solved using NSGA-II (a genetic algorithm). The results of this optimization for a single ACJ during upstroke and downstroke are presented in this paper. Results of two different loading conditions used during optimization of a single ACJ for upstroke are presented. Finally, optimization results comparing the performance of compliant mechanisms with one and two ACJs are also presented. It can be inferred from these results that the number of ACJs and the design of each ACJ determines the stiffness of the bend-and-sweep compliant mechanism. These mechanisms can be used in various applications. The goal of this research is to improve the performance of ornithopters by passively morphing their wings. In order to achieve a bio-inspired wing gait called continuous vortex gait, the wings of the ornithopter need to bend, and sweep simultaneously. This can be achieved by inserting the bend-and-sweep compliant mechanism into the leading edge wing spar of the ornithopters. (paper)

  4. JIT-transportation problem and its algorithm

    Science.gov (United States)

    Bai, Guozhong; Gan, Xiao-Xiong

    2011-12-01

    This article introduces the (just-in-time) JIT-transportation problem, which requires that all demanded goods be shipped to their destinations on schedule, at a zero or minimal destination-storage cost. The JIT-transportation problem is a special goal programming problem with discrete constraints. This article provides a mathematical model for such a transportation problem and introduces the JIT solution, the deviation solution, the JIT deviation, etc. By introducing the B(λ)-problem, this article establishes the equivalence between the optimal solutions of the B(λ)-problem and the optimal solutions of the JIT-transportation problem, and then provides an algorithm for the JIT-transportation problems. This algorithm is proven mathematically and is also illustrated by an example.

  5. A transport synthetic acceleration method for transport iterations

    International Nuclear Information System (INIS)

    Ramone, G.L.; Adams, M.L.

    1997-01-01

    A family of transport synthetic acceleration (TSA) methods for iteratively solving within group scattering problems is presented. A single iteration in these schemes consists of a transport sweep followed by a low-order calculation, which itself is a simplified transport problem. The method for isotropic-scattering problems in X-Y geometry is described. The Fourier analysis of a model problem for equations with no spatial discretization shows that a previously proposed TSA method is unstable in two dimensions but that the modifications make it stable and rapidly convergent. The same procedure for discretized transport equations, using the step characteristic and two bilinear discontinuous methods, shows that discretization enhances TSA performance. A conjugate gradient algorithm for the low-order problem is described, a crude quadrature set for the low-order problem is proposed, and the number of low-order iterations per high-order sweep is limited to a relatively small value. These features lead to simple and efficient improvements to the method. TSA is tested on a series of problems, and a set of parameters is proposed for which the method behaves especially well. TSA achieves a substantial reduction in computational cost over source iteration, regardless of discretization parameters or material properties, and this reduction increases with the difficulty of the problem

  6. Laminar/transition sweeping flow-mixing model for wire-wrapped LMFBR assemblies

    International Nuclear Information System (INIS)

    Burns, K.F.; Rohsenow, W.M.; Todreas, N.E.

    1980-07-01

    Recent interest in analyzing the thermal hydraulic characteristics of LMFBR assemblies operating in the mixed convection regime motivates the extension of the aforementioned turbulent sweeping flow model to low Reynolds number flows. The accuracy to which knowledge of the mixing parameters is required has not been well determined, due to the increased influence of conduction and buoyancy effects with respect to energy transport at low Reynolds numbers. This study represents a best estimate attempt to correlate the existing low Reynolds number sweeping flow data. The laminar/transition model which is presented is expected to be useful in anayzing mixed convection conditions. However, the justification for making additional improvemements is contingent upon two factors. First, the ability of the proposed laminar/transition model to predict additional low Reynolds number sweeping flow data for other geometries needs to be investigated. Secondly, the sensitivity of temperature predictions to uncertainties in the values of the sweeping flow parameters should be quantified

  7. Soft shoulders ahead: spurious signatures of soft and partial selective sweeps result from linked hard sweeps.

    Science.gov (United States)

    Schrider, Daniel R; Mendes, Fábio K; Hahn, Matthew W; Kern, Andrew D

    2015-05-01

    Characterizing the nature of the adaptive process at the genetic level is a central goal for population genetics. In particular, we know little about the sources of adaptive substitution or about the number of adaptive variants currently segregating in nature. Historically, population geneticists have focused attention on the hard-sweep model of adaptation in which a de novo beneficial mutation arises and rapidly fixes in a population. Recently more attention has been given to soft-sweep models, in which alleles that were previously neutral, or nearly so, drift until such a time as the environment shifts and their selection coefficient changes to become beneficial. It remains an active and difficult problem, however, to tease apart the telltale signatures of hard vs. soft sweeps in genomic polymorphism data. Through extensive simulations of hard- and soft-sweep models, here we show that indeed the two might not be separable through the use of simple summary statistics. In particular, it seems that recombination in regions linked to, but distant from, sites of hard sweeps can create patterns of polymorphism that closely mirror what is expected to be found near soft sweeps. We find that a very similar situation arises when using haplotype-based statistics that are aimed at detecting partial or ongoing selective sweeps, such that it is difficult to distinguish the shoulder of a hard sweep from the center of a partial sweep. While knowing the location of the selected site mitigates this problem slightly, we show that stochasticity in signatures of natural selection will frequently cause the signal to reach its zenith far from this site and that this effect is more severe for soft sweeps; thus inferences of the target as well as the mode of positive selection may be inaccurate. In addition, both the time since a sweep ends and biologically realistic levels of allelic gene conversion lead to errors in the classification and identification of selective sweeps. This

  8. Plasma turbulence measured by fast sweep reflectometry on Tore Supra

    International Nuclear Information System (INIS)

    Clairet, F.; Vermare, L.; Leclert, G.

    2004-01-01

    Traditionally devoted to electron density profile measurement we show that fast frequency sweeping reflectometry technique can bring valuable and innovative measurements onto plasma turbulence. While fast frequency sweeping technique is traditionally devoted to electron density radial profile measurements we show in this paper how we can handle the fluctuations of the reflected signal to recover plasma density fluctuation measurements with a high spatial and temporal resolution. Large size turbulence related to magneto-hydrodynamic (MHD) activity and the associated magnetic islands can be detected. The radial profile of the micro-turbulence, which is responsible for plasma anomalous transport processes, is experimentally determined through the fluctuation of the reflected phase signal. (authors)

  9. Plasma turbulence measured by fast sweep reflectometry on Tore Supra

    International Nuclear Information System (INIS)

    Clairet, F.; Vermare, L.; Heuraux, S.; Leclert, G.

    2004-01-01

    Traditionally devoted to electron density profile measurement we show that fast frequency sweeping reflectometry technique can bring valuable and innovative measurements onto plasma turbulence. While fast frequency sweeping technique is traditionally devoted to electron density radial profile measurements we show in this paper how we can handle the fluctuations of the reflected signal to recover plasma density fluctuation measurements with a high spatial and temporal resolution. Large size turbulence related to magneto-hydrodynamic (MHD) activity and the associated magnetic islands can be detected. The radial profile of the micro-turbulence, which is responsible for plasma anomalous transport processes, is experimentally determined through the fluctuation of the reflected phase signal

  10. Application of preconditioned GMRES to the numerical solution of the neutron transport equation

    International Nuclear Information System (INIS)

    Patton, B.W.; Holloway, J.P.

    2002-01-01

    The generalized minimal residual (GMRES) method with right preconditioning is examined as an alternative to both standard and accelerated transport sweeps for the iterative solution of the diamond differenced discrete ordinates neutron transport equation. Incomplete factorization (ILU) type preconditioners are used to determine their effectiveness in accelerating GMRES for this application. ILU(τ), which requires the specification of a dropping criteria τ, proves to be a good choice for the types of problems examined in this paper. The combination of ILU(τ) and GMRES is compared with both DSA and unaccelerated transport sweeps for several model problems. It is found that the computational workload of the ILU(τ)-GMRES combination scales nonlinearly with the number of energy groups and quadrature order, making this technique most effective for problems with a small number of groups and discrete ordinates. However, the cost of preconditioner construction can be amortized over several calculations with different source and/or boundary values. Preconditioners built upon standard transport sweep algorithms are also evaluated as to their effectiveness in accelerating the convergence of GMRES. These preconditioners show better scaling with such problem parameters as the scattering ratio, the number of discrete ordinates, and the number of spatial meshes. These sweeps based preconditioners can also be cast in a matrix free form that greatly reduces storage requirements

  11. Parallelization of a spherical Sn transport theory algorithm

    International Nuclear Information System (INIS)

    Haghighat, A.

    1989-01-01

    The work described in this paper derives a parallel algorithm for an R-dependent spherical S N transport theory algorithm and studies its performance by testing different sample problems. The S N transport method is one of the most accurate techniques used to solve the linear Boltzmann equation. Several studies have been done on the vectorization of the S N algorithms; however, very few studies have been performed on the parallelization of this algorithm. Weinke and Hommoto have looked at the parallel processing of the different energy groups, and Azmy recently studied the parallel processing of the inner iterations of an X-Y S N nodal transport theory method. Both studies have reported very encouraging results, which have prompted us to look at the parallel processing of an R-dependent S N spherical geometry algorithm. This geometry was chosen because, in spite of its simplicity, it contains the complications of the curvilinear geometries (i.e., redistribution of neutrons over the discretized angular bins)

  12. A transport-based condensed history algorithm

    International Nuclear Information System (INIS)

    Tolar, D. R. Jr.

    1999-01-01

    Condensed history algorithms are approximate electron transport Monte Carlo methods in which the cumulative effects of multiple collisions are modeled in a single step of (user-specified) path length s 0 . This path length is the distance each Monte Carlo electron travels between collisions. Current condensed history techniques utilize a splitting routine over the range 0 le s le s 0 . For example, the PEnELOPE method splits each step into two substeps; one with length ξs 0 and one with length (1 minusξ)s 0 , where ξ is a random number from 0 0 is fixed (not sampled from an exponential distribution), conventional condensed history schemes are not transport processes. Here the authors describe a new condensed history algorithm that is a transport process. The method simulates a transport equation that approximates the exact Boltzmann equation. The new transport equation has a larger mean free path than, and preserves two angular moments of, the Boltzmann equation. Thus, the new process is solved more efficiently by Monte Carlo, and it conserves both particles and scattering power

  13. Sweep time performance of optic streak camera

    International Nuclear Information System (INIS)

    Wang Zhebin; Yang Dong; Zhang Huige

    2012-01-01

    The sweep time performance of the optic streak camera (OSC) is of critical importance to its application. The systematic analysis of full-screen sweep velocity shows that the traditional method based on the averaged velocity and its nonlinearity would increase the uncertainty of sweep time and can not reflect the influence of the spatial distortion of OSC. A elaborate method for sweep time has been developed with the aid of full-screen sweep velocity and its uncertainty. It is proved by the theoretical analysis and experimental study that the method would decrease the uncertainty of sweep time within 1%, which would improve the accuracy of sweep time and the reliability of OSC application. (authors)

  14. Ship Block Transportation Scheduling Problem Based on Greedy Algorithm

    Directory of Open Access Journals (Sweden)

    Chong Wang

    2016-05-01

    Full Text Available Ship block transportation problems are crucial issues to address in reducing the construction cost and improving the productivity of shipyards. Shipyards aim to maximize the workload balance of transporters with time constraint such that all blocks should be transported during the planning horizon. This process leads to three types of penalty time: empty transporter travel time, delay time, and tardy time. This study aims to minimize the sum of the penalty time. First, this study presents the problem of ship block transportation with the generalization of the block transportation restriction on the multi-type transporter. Second, the problem is transformed into the classical traveling salesman problem and assignment problem through a reasonable model simplification and by adding a virtual node to the proposed directed graph. Then, a heuristic algorithm based on greedy algorithm is proposed to assign blocks to available transporters and sequencing blocks for each transporter simultaneously. Finally, the numerical experiment method is used to validate the model, and its result shows that the proposed algorithm is effective in realizing the efficient use of the transporters in shipyards. Numerical simulation results demonstrate the promising application of the proposed method to efficiently improve the utilization of transporters and to reduce the cost of ship block logistics for shipyards.

  15. Sustainable logistics and transportation optimization models and algorithms

    CERN Document Server

    Gakis, Konstantinos; Pardalos, Panos

    2017-01-01

    Focused on the logistics and transportation operations within a supply chain, this book brings together the latest models, algorithms, and optimization possibilities. Logistics and transportation problems are examined within a sustainability perspective to offer a comprehensive assessment of environmental, social, ethical, and economic performance measures. Featured models, techniques, and algorithms may be used to construct policies on alternative transportation modes and technologies, green logistics, and incentives by the incorporation of environmental, economic, and social measures. Researchers, professionals, and graduate students in urban regional planning, logistics, transport systems, optimization, supply chain management, business administration, information science, mathematics, and industrial and systems engineering will find the real life and interdisciplinary issues presented in this book informative and useful.

  16. Algorithm for the Stochastic Generalized Transportation Problem

    Directory of Open Access Journals (Sweden)

    Marcin Anholcer

    2012-01-01

    Full Text Available The equalization method for the stochastic generalized transportation problem has been presented. The algorithm allows us to find the optimal solution to the problem of minimizing the expected total cost in the generalized transportation problem with random demand. After a short introduction and literature review, the algorithm is presented. It is a version of the method proposed by the author for the nonlinear generalized transportation problem. It is shown that this version of the method generates a sequence of solutions convergent to the KKT point. This guarantees the global optimality of the obtained solution, as the expected cost functions are convex and twice differentiable. The computational experiments performed for test problems of reasonable size show that the method is fast. (original abstract

  17. Sweeping Gas Membrane Desalination Using Commercial Hydrophobic Hollow Fiber Membranes; TOPICAL

    International Nuclear Information System (INIS)

    EVANS, LINDSEY; MILLER, JAMES E.

    2002-01-01

    Water shortages affect 88 developing countries that are home to half of the world's population. In these places, 80-90% of all diseases and 30% of all deaths result from poor water quality. Furthermore, over the next 25 years, the number of people affected by severe water shortages is expected to increase fourfold. Low cost methods of purifying freshwater, and desalting seawater are required to contend with this destabilizing trend. Membrane distillation (MD) is an emerging technology for separations that are traditionally accomplished via conventional distillation or reverse osmosis. As applied to desalination, MD involves the transport of water vapor from a saline solution through the pores of a hydrophobic membrane. In sweeping gas MD, a flowing gas stream is used to flush the water vapor from the permeate side of the membrane, thereby maintaining the vapor pressure gradient necessary for mass transfer. Since liquid does not penetrate the hydrophobic membrane, dissolved ions are completely rejected by the membrane. MD has a number of potential advantages over conventional desalination including low temperature and pressure operation, reduced membrane strength requirements, compact size, and 100% rejection of non-volatiles. The present work evaluated the suitability of commercially available technology for sweeping gas membrane desalination. Evaluations were conducted with Celgard Liqui-Cel(reg s ign) Extra-Flow 2.5X8 membrane contactors with X-30 and X-40 hydrophobic hollow fiber membranes. Our results show that sweeping gas membrane desalination systems are capable of producing low total dissolved solids (TDS) water, typically 10 ppm or less, from seawater, using low grade heat. However, there are several barriers that currently prevent sweeping gas MD from being a viable desalination technology. The primary problem is that large air flows are required to achieve significant water yields, and the costs associated with transporting this air are prohibitive. To

  18. Variable depth recursion algorithm for leaf sequencing

    International Nuclear Information System (INIS)

    Siochi, R. Alfredo C.

    2007-01-01

    The processes of extraction and sweep are basic segmentation steps that are used in leaf sequencing algorithms. A modified version of a commercial leaf sequencer changed the way that the extracts are selected and expanded the search space, but the modification maintained the basic search paradigm of evaluating multiple solutions, each one consisting of up to 12 extracts and a sweep sequence. While it generated the best solutions compared to other published algorithms, it used more computation time. A new, faster algorithm selects one extract at a time but calls itself as an evaluation function a user-specified number of times, after which it uses the bidirectional sweeping window algorithm as the final evaluation function. To achieve a performance comparable to that of the modified commercial leaf sequencer, 2-3 calls were needed, and in all test cases, there were only slight improvements beyond two calls. For the 13 clinical test maps, computation speeds improved by a factor between 12 and 43, depending on the constraints, namely the ability to interdigitate and the avoidance of the tongue-and-groove under dose. The new algorithm was compared to the original and modified versions of the commercial leaf sequencer. It was also compared to other published algorithms for 1400, random, 15x15, test maps with 3-16 intensity levels. In every single case the new algorithm provided the best solution

  19. Advective isotope transport by mixing cell and particle tracking algorithms

    International Nuclear Information System (INIS)

    Tezcan, L.; Meric, T.

    1999-01-01

    The 'mixing cell' algorithm of the environmental isotope data evaluation is integrated with the three dimensional finite difference ground water flow model (MODFLOW) to simulate the advective isotope transport and the approach is compared with the 'particle tracking' algorithm of the MOC3D, that simulates three-dimensional solute transport with the method of characteristics technique

  20. Public Transport Route Finding using a Hybrid Genetic Algorithm

    OpenAIRE

    Liviu Adrian COTFAS; Andreea DIOSTEANU

    2011-01-01

    In this paper we present a public transport route finding solution based on a hybrid genetic algorithm. The algorithm uses two heuristics that take into consideration the number of trans-fers and the remaining distance to the destination station in order to improve the convergence speed. The interface of the system uses the latest web technologies to offer both portability and advanced functionality. The approach has been evaluated using the data for the Bucharest public transport network.

  1. Fast backprojection-based reconstruction of spectral-spatial EPR images from projections with the constant sweep of a magnetic field.

    Science.gov (United States)

    Komarov, Denis A; Hirata, Hiroshi

    2017-08-01

    In this paper, we introduce a procedure for the reconstruction of spectral-spatial EPR images using projections acquired with the constant sweep of a magnetic field. The application of a constant field-sweep and a predetermined data sampling rate simplifies the requirements for EPR imaging instrumentation and facilitates the backprojection-based reconstruction of spectral-spatial images. The proposed approach was applied to the reconstruction of a four-dimensional numerical phantom and to actual spectral-spatial EPR measurements. Image reconstruction using projections with a constant field-sweep was three times faster than the conventional approach with the application of a pseudo-angle and a scan range that depends on the applied field gradient. Spectral-spatial EPR imaging with a constant field-sweep for data acquisition only slightly reduces the signal-to-noise ratio or functional resolution of the resultant images and can be applied together with any common backprojection-based reconstruction algorithm. Copyright © 2017 Elsevier Inc. All rights reserved.

  2. Public Transport Route Finding using a Hybrid Genetic Algorithm

    Directory of Open Access Journals (Sweden)

    Liviu Adrian COTFAS

    2011-01-01

    Full Text Available In this paper we present a public transport route finding solution based on a hybrid genetic algorithm. The algorithm uses two heuristics that take into consideration the number of trans-fers and the remaining distance to the destination station in order to improve the convergence speed. The interface of the system uses the latest web technologies to offer both portability and advanced functionality. The approach has been evaluated using the data for the Bucharest public transport network.

  3. Spatial domain decomposition for neutron transport problems

    International Nuclear Information System (INIS)

    Yavuz, M.; Larsen, E.W.

    1989-01-01

    A spatial Domain Decomposition method is proposed for modifying the Source Iteration (SI) and Diffusion Synthetic Acceleration (DSA) algorithms for solving discrete ordinates problems. The method, which consists of subdividing the spatial domain of the problem and performing the transport sweeps independently on each subdomain, has the advantage of being parallelizable because the calculations in each subdomain can be performed on separate processors. In this paper we describe the details of this spatial decomposition and study, by numerical experimentation, the effect of this decomposition on the SI and DSA algorithms. Our results show that the spatial decomposition has little effect on the convergence rates until the subdomains become optically thin (less than about a mean free path in thickness)

  4. Thermal effects of divertor sweeping in ITER

    International Nuclear Information System (INIS)

    Wesley, J.C.

    1992-01-01

    In this paper, thermal effects of magnetically sweeping the separatrix strike point on the outer divertor target of the International Thermonuclear Fusion Reactor (ITER) are calculated. For the 0. 2 Hz x ± 12 cm sweep scenario proposed for ITER operations, the thermal capability of a generic target design is found to be slightly inadequate (by ∼ 5%) to accommodate the full degree of plasma scrape-off peaking postulated as a design basis. The principal problem identified is that the 5 s sweep period is long relative to the 1. 4 s thermal time constant of the divertor target. An increase of the sweep frequency to ∼ 1 Hz is suggested: this increase would provide a power handling margin of ∼ 25% relative to present operational criteria

  5. A Novel Algorithm for Solving the Multidimensional Neutron Transport Equation on Massively Parallel Architectures

    Energy Technology Data Exchange (ETDEWEB)

    Azmy, Yousry

    2014-06-10

    We employ the Integral Transport Matrix Method (ITMM) as the kernel of new parallel solution methods for the discrete ordinates approximation of the within-group neutron transport equation. The ITMM abandons the repetitive mesh sweeps of the traditional source iterations (SI) scheme in favor of constructing stored operators that account for the direct coupling factors among all the cells' fluxes and between the cells' and boundary surfaces' fluxes. The main goals of this work are to develop the algorithms that construct these operators and employ them in the solution process, determine the most suitable way to parallelize the entire procedure, and evaluate the behavior and parallel performance of the developed methods with increasing number of processes, P. The fastest observed parallel solution method, Parallel Gauss-Seidel (PGS), was used in a weak scaling comparison with the PARTISN transport code, which uses the source iteration (SI) scheme parallelized with the Koch-baker-Alcouffe (KBA) method. Compared to the state-of-the-art SI-KBA with diffusion synthetic acceleration (DSA), this new method- even without acceleration/preconditioning-is completitive for optically thick problems as P is increased to the tens of thousands range. For the most optically thick cells tested, PGS reduced execution time by an approximate factor of three for problems with more than 130 million computational cells on P = 32,768. Moreover, the SI-DSA execution times's trend rises generally more steeply with increasing P than the PGS trend. Furthermore, the PGS method outperforms SI for the periodic heterogeneous layers (PHL) configuration problems. The PGS method outperforms SI and SI-DSA on as few as P = 16 for PHL problems and reduces execution time by a factor of ten or more for all problems considered with more than 2 million computational cells on P = 4.096.

  6. Investigation of Spiral and Sweeping Holes

    Science.gov (United States)

    Thurman, Douglas; Poinsatte, Philip; Ameri, Ali; Culley, Dennis; Raghu, Surya; Shyam, Vikram

    2015-01-01

    Surface infrared thermography, hotwire anemometry, and thermocouple surveys were performed on two new film cooling hole geometries: spiral/rifled holes and fluidic sweeping holes. The spiral holes attempt to induce large-scale vorticity to the film cooling jet as it exits the hole to prevent the formation of the kidney shaped vortices commonly associated with film cooling jets. The fluidic sweeping hole uses a passive in-hole geometry to induce jet sweeping at frequencies that scale with blowing ratios. The spiral hole performance is compared to that of round holes with and without compound angles. The fluidic hole is of the diffusion class of holes and is therefore compared to a 777 hole and Square holes. A patent-pending spiral hole design showed the highest potential of the non-diffusion type hole configurations. Velocity contours and flow temperature were acquired at discreet cross-sections of the downstream flow field. The passive fluidic sweeping hole shows the most uniform cooling distribution but suffers from low span-averaged effectiveness levels due to enhanced mixing. The data was taken at a Reynolds number of 11,000 based on hole diameter and freestream velocity. Infrared thermography was taken for blowing rations of 1.0, 1.5, 2.0, and 2.5 at a density ration of 1.05. The flow inside the fluidic sweeping hole was studied using 3D unsteady RANS.

  7. Optimization of China Crude Oil Transportation Network with Genetic Ant Colony Algorithm

    Directory of Open Access Journals (Sweden)

    Yao Wang

    2015-08-01

    Full Text Available Taking into consideration both shipping and pipeline transport, this paper first analysed the risk factors for different modes of crude oil import transportation. Then, based on the minimum of both transportation cost and overall risk, a multi-objective programming model was established to optimize the transportation network of crude oil import, and the genetic algorithm and ant colony algorithm were employed to solve the problem. The optimized result shows that VLCC (Very Large Crude Carrier is superior in long distance sea transportation, whereas pipeline transport is more secure than sea transport. Finally, this paper provides related safeguard suggestions on crude oil import transportation.

  8. Cooperative Research Twin Trawl Sweep Comparison Study

    Data.gov (United States)

    National Oceanic and Atmospheric Administration, Department of Commerce — The "Twin-Trawl Sweep Efficiency Study" was intended to compare the sweep efficiency and selectivity of the NEFSC standardized bottom trawl to that of a standardized...

  9. Development of parallel 3D discrete ordinates transport program on JASMIN framework

    International Nuclear Information System (INIS)

    Cheng, T.; Wei, J.; Shen, H.; Zhong, B.; Deng, L.

    2015-01-01

    A parallel 3D discrete ordinates radiation transport code JSNT-S is developed, aiming at simulating real-world radiation shielding and reactor physics applications in a reasonable time. Through the patch-based domain partition algorithm, the memory requirement is shared among processors and a space-angle parallel sweeping algorithm is developed based on data-driven algorithm. Acceleration methods such as partial current rebalance are implemented. The correctness is proved through the VENUS-3 and other benchmark models. In the radiation shielding calculation of the Qinshan-II reactor pressure vessel model with 24.3 billion DoF, only 88 seconds is required and the overall parallel efficiency of 44% is achieved on 1536 CPU cores. (author)

  10. Sweeping at the Martin boundary of a fine domain

    DEFF Research Database (Denmark)

    El Kadiri, Mohamed; Fuglede, Bent

    2016-01-01

    We study sweeping on a subset of the Riesz-Martin space of a fine domain in R n   (n≥2), both with respect to the natural topology and the minimal-fine topology, and show that the two notions of sweeping are identical.......We study sweeping on a subset of the Riesz-Martin space of a fine domain in R n   (n≥2), both with respect to the natural topology and the minimal-fine topology, and show that the two notions of sweeping are identical....

  11. Fast algorithms for transport models. Final report, June 1, 1993--May 31, 1994

    International Nuclear Information System (INIS)

    Manteuffel, T.

    1994-12-01

    The focus of this project is the study of multigrid and multilevel algorithms for the numerical solution of Boltzmann models of the transport of neutral and charged particles. In previous work a fast multigrid algorithm was developed for the numerical solution of the Boltzmann model of neutral particle transport in slab geometry assuming isotropic scattering. The new algorithm is extremely fast in the thick diffusion limit; the multigrid v-cycle convergence factor approaches zero as the mean-free-path between collisions approaches zero, independent of the mesh. Also, a fast multilevel method was developed for the numerical solution of the Boltzmann model of charged particle transport in the thick Fokker-Plank limit for slab geometry. Parallel implementations were developed for both algorithms

  12. Improving the sweeping efficiency of permanganate into low permeable zones to treat TCE: experimental results and model development.

    Science.gov (United States)

    Chokejaroenrat, Chanat; Kananizadeh, Negin; Sakulthaew, Chainarong; Comfort, Steve; Li, Yusong

    2013-11-19

    The residual buildup and treatment of dissolved contaminants in low permeable zones (LPZs) is a particularly challenging issue for injection-based remedial treatments. Our objective was to improve the sweeping efficiency of permanganate into LPZs to treat dissolved-phase TCE. This was accomplished by conducting transport experiments that quantified the ability of xanthan-MnO4(-) solutions to penetrate and cover (i.e., sweep) an LPZ that was surrounded by transmissive sands. By incorporating the non-Newtonian fluid xanthan with MnO4(-), penetration of MnO4(-) into the LPZ improved dramatically and sweeping efficiency reached 100% in fewer pore volumes. To quantify how xanthan improved TCE removal, we spiked the LPZ and surrounding sands with (14)C-lableled TCE and used a multistep flooding procedure that quantified the mass of (14)C-TCE oxidized and bypassed during treatment. Results showed that TCE mass removal was 1.4 times greater in experiments where xanthan was employed. Combining xanthan with MnO4(-) also reduced the mass of TCE in the LPZ that was potentially available for rebound. By coupling a multiple species reactive transport model with the Brinkman equation for non-Newtonian flow, the simulated amount of (14)C-TCE oxidized during transport matched experimental results. These observations support the use of xanthan as a means of enhancing MnO4(-) delivery into LPZs for the treatment of dissolved-phase TCE.

  13. The sweep-line state space exploration method

    DEFF Research Database (Denmark)

    Jensen, Kurt; Kristensen, Lars M.; Mailund, Thomas

    2012-01-01

    . The contribution of this paper is twofold. First, we provide a coherent presentation of the sweep-line theory and the many variants of the method that have been developed over the past 10 years since the basic idea of the method was conceived. Second, we survey a selection of case studies where the sweep...

  14. 3D neutron transport modelization

    International Nuclear Information System (INIS)

    Warin, X.

    1996-12-01

    Some nodal methods to solve the transport equation in 3D are presented. Two nodal methods presented at an OCDE congress are described: a first one is a low degree one called RTN0; a second one is a high degree one called BDM1. The two methods can be made faster with a totally consistent DSA. Some results of parallelization show that: 98% of the time is spent in sweeps; transport sweeps are easily parallelized. (K.A.)

  15. Parallel/vector algorithms for the spherical SN transport theory method

    International Nuclear Information System (INIS)

    Haghighat, A.; Mattis, R.E.

    1990-01-01

    This paper discusses vector and parallel processing of a 1-D curvilinear (i.e. spherical) S N transport theory algorithm on the Cornell National SuperComputer Facility (CNSF) IBM 3090/600E. Two different vector algorithms were developed and parallelized based on angular decomposition. It is shown that significant speedups are attainable. For example, for problems with large granularity, using 4 processors, the parallel/vector algorithm achieves speedups (for wall-clock time) of more than 4.5 relative to the old serial/scalar algorithm. Furthermore, this work has demonstrated the existing potential for the development of faster processing vector and parallel algorithms for multidimensional curvilinear geometries. (author)

  16. Sweeping a persisting superconducting magnet with a transformer

    International Nuclear Information System (INIS)

    Spencer, G.F.; Alexander, P.W.; Ihas, G.G.

    1982-01-01

    A method for sweeping a persisting superconducting magnet is described. The field sweep is achieved by including in the superconducting loop of the magnet a coil which acts as the secondary coil of a transformer. Variation of the current in the primary coil of the transformer, controlled from outside the cryostat, causes the field-sweeping action through flux-linking with the superconducting loop. Compared to directly changing the current in a magnet, this technique improves control by the ratio of the magnet's inductance to the transformer's inductance. The advantages of using an all-metal vacuum-tight superconducting feedthrough are discussed. (author)

  17. 3D neutron transport modelization

    Energy Technology Data Exchange (ETDEWEB)

    Warin, X.

    1996-12-01

    Some nodal methods to solve the transport equation in 3D are presented. Two nodal methods presented at an OCDE congress are described: a first one is a low degree one called RTN0; a second one is a high degree one called BDM1. The two methods can be made faster with a totally consistent DSA. Some results of parallelization show that: 98% of the time is spent in sweeps; transport sweeps are easily parallelized. (K.A.). 10 refs.

  18. Algorithm for Public Electric Transport Schedule Control for Intelligent Embedded Devices

    Science.gov (United States)

    Alps, Ivars; Potapov, Andrey; Gorobetz, Mikhail; Levchenkov, Anatoly

    2010-01-01

    In this paper authors present heuristics algorithm for precise schedule fulfilment in city traffic conditions taking in account traffic lights. The algorithm is proposed for programmable controller. PLC is proposed to be installed in electric vehicle to control its motion speed and signals of traffic lights. Algorithm is tested using real controller connected to virtual devices and real functional models of real tram devices. Results of experiments show high precision of public transport schedule fulfilment using proposed algorithm.

  19. Automatic sweep circuit

    Science.gov (United States)

    Keefe, Donald J.

    1980-01-01

    An automatically sweeping circuit for searching for an evoked response in an output signal in time with respect to a trigger input. Digital counters are used to activate a detector at precise intervals, and monitoring is repeated for statistical accuracy. If the response is not found then a different time window is examined until the signal is found.

  20. Particle swarm optimization - Genetic algorithm (PSOGA) on linear transportation problem

    Science.gov (United States)

    Rahmalia, Dinita

    2017-08-01

    Linear Transportation Problem (LTP) is the case of constrained optimization where we want to minimize cost subject to the balance of the number of supply and the number of demand. The exact method such as northwest corner, vogel, russel, minimal cost have been applied at approaching optimal solution. In this paper, we use heurisitic like Particle Swarm Optimization (PSO) for solving linear transportation problem at any size of decision variable. In addition, we combine mutation operator of Genetic Algorithm (GA) at PSO to improve optimal solution. This method is called Particle Swarm Optimization - Genetic Algorithm (PSOGA). The simulations show that PSOGA can improve optimal solution resulted by PSO.

  1. Adiabatic sweep pulses for earth's field NMR with a surface coil

    Science.gov (United States)

    Conradi, Mark S.; Altobelli, Stephen A.; Sowko, Nicholas J.; Conradi, Susan H.; Fukushima, Eiichi

    2018-03-01

    Adiabatic NMR sweep pulses are described for inversion and excitation in very low magnetic fields B0 and with broad distribution of excitation field amplitude B1. Two aspects distinguish the low field case: (1) when B1 is comparable to or greater than B0, the rotating field approximation fails and (2) inversion sweeps cannot extend to values well below the Larmor frequency because they would approach or pass through zero frequency. Three approaches to inversion are described. The first is a conventional tangent frequency sweep down to the Larmor frequency, a 180° phase shift, and a sweep back up to the starting frequency. The other two are combined frequency and amplitude sweeps covering a narrower frequency range; one is a symmetric sweep from above to below the Larmor frequency and the other uses a smooth decrease of B1 immediately before and after the 180° phase shift. These two AM/FM sweeps show excellent inversion efficiencies over a wide range of B1, a factor of 30 or more. We also demonstrate an excitation sweep that works well in the presence of the same wide range of B1. We show that the primary effect of the counter-rotating field (i.e., at low B0) is that the magnetization suffers large, periodic deviations from where it would be at large B0. Thus, successful sweep pulses must avoid any sharp features in the amplitude, phase, or frequency.

  2. Theoretical approach to cell-impedance-controlled lithium transport through Li1-δMn2O4 film electrode with partially inactive fractal surface by analyses of potentiostatic current transient and linear sweep voltammogram

    International Nuclear Information System (INIS)

    Jung, Kyu-Nam; Pyun, Su-Il

    2007-01-01

    Lithium transport through the partially inactive fractal Li 1-δ Mn 2 O 4 film electrode under the cell-impedance-controlled constraint was theoretically investigated by using the kinetic Monte Carlo method based upon random walk approach. Under the cell-impedance-controlled constraint, all the potentiostatic current transients calculated from the totally active and partially inactive fractal electrodes hardly exhibited the generalised Cottrell behaviour and they were significantly affected in shape by the interfacial charge-transfer kinetics. In the case of the linear sweep voltammogram determined from the totally active and partially inactive fractal electrodes, all the power dependence of the peak current on the scan rate above the characteristic scan rate deviated from the generalised Randles-Sevcik behaviour. From the analyses of the current transients and the linear sweep voltammograms simulated with various values of the simulation parameters, it was further recognised that the cell-impedance-controlled lithium transport through the partially inactive fractal Li 1-δ Mn 2 O 4 film electrode strongly deviates from the generalised diffusion-controlled transport behaviour of the electrode with the totally active surface, which is attributed to the impeded interfacial charge-transfer kinetics governed by the surface inhomogeneities including the fractal dimension of the surface and the surface coverage by active sites and by the kinetic parameters including the internal cell resistance

  3. Automatic sweep circuit

    International Nuclear Information System (INIS)

    Keefe, D.J.

    1980-01-01

    An automatically sweeping circuit for searching for an evoked response in an output signal in time with respect to a trigger input is described. Digital counters are used to activate a detector at precise intervals, and monitoring is repeated for statistical accuracy. If the response is not found then a different time window is examined until the signal is found

  4. ASU nitrogen sweep gas in hydrogen separation membrane for production of HRSG duct burner fuel

    Science.gov (United States)

    Panuccio, Gregory J.; Raybold, Troy M.; Jamal, Agil; Drnevich, Raymond Francis

    2013-04-02

    The present invention relates to the use of low pressure N2 from an air separation unit (ASU) for use as a sweep gas in a hydrogen transport membrane (HTM) to increase syngas H2 recovery and make a near-atmospheric pressure (less than or equal to about 25 psia) fuel for supplemental firing in the heat recovery steam generator (HRSG) duct burner.

  5. A Generalised Sweep-Line Method for Safety Properties

    DEFF Research Database (Denmark)

    Mailund; Kristensen, Lars Michael

    2002-01-01

    The recently developed sweep-line method exploits progress present in many concurrent systems to explore the full state space of the system while storing only small fragments of the state space in memory at a time. A disadvantage of the sweep-line method is that it relies on a monotone and global...

  6. Automatically sweeping dual-channel boxcar integrator

    International Nuclear Information System (INIS)

    Keefe, D.J.; Patterson, D.R.

    1978-01-01

    An automatically sweeping dual-channel boxcar integrator has been developed to automate the search for a signal that repeatedly follows a trigger pulse by a constant or slowly varying time delay when that signal is completely hidden in random electrical noise and dc-offset drifts. The automatically sweeping dual-channel boxcar integrator improves the signal-to-noise ratio and eliminates dc-drift errors in the same way that a conventional dual-channel boxcar integrator does, but, in addition, automatically locates the hidden signal. When the signal is found, its time delay is displayed with 100-ns resolution, and its peak value is automatically measured and displayed. This relieves the operator of the tedious, time-consuming, and error-prone search for the signal whenever the time delay changes. The automatically sweeping boxcar integrator can also be used as a conventional dual-channel boxcar integrator. In either mode, it can repeatedly integrate a signal up to 990 times and thus make accurate measurements of the signal pulse height in the presence of random noise, dc offsets, and unsynchronized interfering signals

  7. Fully multidimensional flux-corrected transport algorithms for fluids

    International Nuclear Information System (INIS)

    Zalesak, S.T.

    1979-01-01

    The theory of flux-corrected transport (FCT) developed by Boris and Book is placed in a simple, generalized format, and a new algorithm for implementing the critical flux limiting stage in multidimensions without resort to time splitting is presented. The new flux limiting algorithm allows the use of FCT techniques in multidimensional fluid problems for which time splitting would produce unacceptable numerical results, such as those involving incompressible or nearly incompressible flow fields. The 'clipping' problem associated with the original one dimensional flux limiter is also eliminated or alleviated. Test results and applications to a two dimensional fluid plasma problem are presented

  8. Southwest Energy Efficiency Project (SWEEP) Final Report

    Energy Technology Data Exchange (ETDEWEB)

    Geller, Howard [Southwest Energy Efficiency Project (SWEEP), Boulder, CO (United States); Meyers, Jim [Southwest Energy Efficiency Project (SWEEP), Boulder, CO (United States)

    2018-01-29

    SWEEP worked with Energy Efficiency and Renewable Energy (EERE) programs to foster greater energy efficiency throughout the Southwest. SWEEP accomplished this through a combination of analysis and support; preparation and distribution of materials on best practice technologies, policies and programs; and technical assistance and information dissemination to states and municipalities in the southwest supporting BTO, AMO, OWIP for advancement of efficiency in products and practices. These efforts were accomplished during the period 2012 through 2017.

  9. Sweep devices for picosecond image-converter streak cameras

    International Nuclear Information System (INIS)

    Cunin, B.; Miehe, J.A.; Sipp, B.; Schelev, M.Ya.; Serduchenko, J.N.; Thebault, J.

    1979-01-01

    Four different sweep devices based on microwave tubes, avalanche transistors, krytrons, and laser-triggered spark gaps are treated in detail. These control circuits are developed for picosecond image-converter cameras and generate sweep pulses providing streak speeds in the range of 10 7 to 5x10 10 cm/sec with maximum time resolution better than 10 -12 sec. Special low-jitter triggering schemes reduce the jitter to less than 5x10 -11 sec. Some problems arising in the construction and matching of the sweep devices and image-streak tube are discussed. Comparative parameters of nanosecond switching elements are presented. The results described can be used by other authors involved in streak camera development

  10. Development of sealing plug for sweep gas line

    International Nuclear Information System (INIS)

    Kikuchi, Taiji; Yamada, Hirokazu; Saitoh, Takashi; Nakamichi, Masaru; Tsuchiya, Kunihiko; Kawamura, Hiroshi

    2004-03-01

    On the irradiation capsule for neutron irradiation test of the tritium breeder, the sealing plug is necessary to prevent a leak of tritium gas when the tritium breeder is picked up from the irradiation capsule after irradiation test. However, the general valve and plug cannot apply to sealing of the sweep gas line because of the following factors, the neutron irradiation effect, limited space in the irradiation capsule, high sealing efficiency, simple method and operation for control. Therefore, the sealing plug for sweep gas line has to be developed. This paper reports the development of the sealing plug for sweep gas line and the operating procedure of the sealing plug in the irradiation capsule. (author)

  11. A parallel version of a multigrid algorithm for isotropic transport equations

    International Nuclear Information System (INIS)

    Manteuffel, T.; McCormick, S.; Yang, G.; Morel, J.; Oliveira, S.

    1994-01-01

    The focus of this paper is on a parallel algorithm for solving the transport equations in a slab geometry using multigrid. The spatial discretization scheme used is a finite element method called the modified linear discontinuous (MLD) scheme. The MLD scheme represents a lumped version of the standard linear discontinuous (LD) scheme. The parallel algorithm was implemented on the Connection Machine 2 (CM2). Convergence rates and timings for this algorithm on the CM2 and Cray-YMP are shown

  12. NOFI oil Vee-Sweep and extension boom test at OHMSETT

    International Nuclear Information System (INIS)

    Bitting, K.R.; Vicedomine, J.

    1993-01-01

    The NOFI Vee-Sweep is an inflatable oil collection boom held in a V configuration by cross netting attached to the skirt of the boom. The NOFI 600S is an inflatable oil boom used to divert oil into the Vee-Sweep. The lower section of the 600S skirt consists of a feather net and a ballast chain. The booms are designed for open-ocean skimming where a skimmer is placed in the Vee-Sweep apex to remove the collected oil. During testing, the booms were preloaded with oil and towed in the OHMSETT tank at various speeds and wave conditions. Each boom was tested for its first and gross (continuous) oil loss speeds. The Vee-Sweep was also evaluated for wave performance, oil thickness vs tow speed, oil loss rate, and critical tow speed. Finally, a DESMI-250 oil skimmer was placed in the Vee-Sweep apex and oil loss tests were run while the skimmer was operating. During the critical tow speed testing, failures occurred due to apex submergence at ca 3.5 knots in calm water and short-crested waves, and 2.4 knots in harbor chop. The oil loss tests showed that the Vee-Sweep retains oil at speeds significantly higher than conventional booms. First oil loss speeds ranged from 1.3 knots in calm water to 1.0 knot in regular waves. The Vee-Sweep's high buoyancy/weight ratio gave it good wave performance in all conditions tested. The 600S oil loss speeds were higher than those of most conventional booms, and performance was better when the feather net was attached. 1 ref., 4 figs., 4 tabs

  13. Simulation of Sweep-Jet Flow Control, Single Jet and Full Vertical Tail

    Science.gov (United States)

    Childs, Robert E.; Stremel, Paul M.; Garcia, Joseph A.; Heineck, James T.; Kushner, Laura K.; Storms, Bruce L.

    2016-01-01

    This work is a simulation technology demonstrator, of sweep jet flow control used to suppress boundary layer separation and increase the maximum achievable load coefficients. A sweep jet is a discrete Coanda jet that oscillates in the plane parallel to an aerodynamic surface. It injects mass and momentum in the approximate streamwise direction. It also generates turbulent eddies at the oscillation frequency, which are typically large relative to the scales of boundary layer turbulence, and which augment mixing across the boundary layer to attack flow separation. Simulations of a fluidic oscillator, the sweep jet emerging from a nozzle downstream of the oscillator, and an array of sweep jets which suppresses boundary layer separation are performed. Simulation results are compared to data from a dedicated validation experiment of a single oscillator and its sweep jet, and from a wind tunnel test of a full-scale Boeing 757 vertical tail augmented with an array of sweep jets. A critical step in the work is the development of realistic time-dependent sweep jet inflow boundary conditions, derived from the results of the single-oscillator simulations, which create the sweep jets in the full-tail simulations. Simulations were performed using the computational fluid dynamics (CFD) solver Overow, with high-order spatial discretization and a range of turbulence modeling. Good results were obtained for all flows simulated, when suitable turbulence modeling was used.

  14. ALGORITHMS FOR TRAFFIC MANAGEMENT IN THE INTELLIGENT TRANSPORT SYSTEMS

    Directory of Open Access Journals (Sweden)

    Andrey Borisovich Nikolaev

    2017-09-01

    Full Text Available Traffic jams interfere with the drivers and cost billions of dollars per year and lead to a substantial increase in fuel consumption. In order to avoid such problems the paper describes the algorithms for traffic management in intelligent transportation system, which collects traffic information in real time and is able to detect and manage congestion on the basis of this information. The results show that the proposed algorithms reduce the average travel time, emissions and fuel consumption. In particular, travel time has decreased by about 23%, the average fuel consumption of 9%, and the average emission of 10%.

  15. Algorithms and file structures for computational geometry

    International Nuclear Information System (INIS)

    Hinrichs, K.; Nievergelt, J.

    1983-01-01

    Algorithms for solving geometric problems and file structures for storing large amounts of geometric data are of increasing importance in computer graphics and computer-aided design. As examples of recent progress in computational geometry, we explain plane-sweep algorithms, which solve various topological and geometric problems efficiently; and we present the grid file, an adaptable, symmetric multi-key file structure that provides efficient access to multi-dimensional data along any space dimension. (orig.)

  16. The Grid[Way] Job Template Manager, a tool for parameter sweeping

    Science.gov (United States)

    Lorca, Alejandro; Huedo, Eduardo; Llorente, Ignacio M.

    2011-04-01

    Parameter sweeping is a widely used algorithmic technique in computational science. It is specially suited for high-throughput computing since the jobs evaluating the parameter space are loosely coupled or independent. A tool that integrates the modeling of a parameter study with the control of jobs in a distributed architecture is presented. The main task is to facilitate the creation and deletion of job templates, which are the elements describing the jobs to be run. Extra functionality relies upon the GridWay Metascheduler, acting as the middleware layer for job submission and control. It supports interesting features like multi-dimensional sweeping space, wildcarding of parameters, functional evaluation of ranges, value-skipping and job template automatic indexation. The use of this tool increases the reliability of the parameter sweep study thanks to the systematic bookkeeping of job templates and respective job statuses. Furthermore, it simplifies the porting of the target application to the grid reducing the required amount of time and effort. Program summaryProgram title: Grid[Way] Job Template Manager (version 1.0) Catalogue identifier: AEIE_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEIE_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: Apache license 2.0 No. of lines in distributed program, including test data, etc.: 3545 No. of bytes in distributed program, including test data, etc.: 126 879 Distribution format: tar.gz Programming language: Perl 5.8.5 and above Computer: Any (tested on PC x86 and x86_64) Operating system: Unix, GNU/Linux (tested on Ubuntu 9.04, Scientific Linux 4.7, centOS 5.4), Mac OS X (tested on Snow Leopard 10.6) RAM: 10 MB Classification: 6.5 External routines: The GridWay Metascheduler [1]. Nature of problem: To parameterize and manage an application running on a grid or cluster. Solution method: Generation of job templates as a cross product of

  17. Development of an inter-layer solute transport algorithm for SOLTR computer program. Part 1. The algorithm

    International Nuclear Information System (INIS)

    Miller, I.; Roman, K.

    1979-12-01

    In order to perform studies of the influence of regional groundwater flow systems on the long-term performance of potential high-level nuclear waste repositories, it was determined that an adequate computer model would have to consider the full three-dimensional flow system. Golder Associates' SOLTR code, while three-dimensional, has an overly simple algorithm for simulating the passage of radionuclides from one aquifier to another above or below it. Part 1 of this report describes the algorithm developed to provide SOLTR with an improved capability for simulating interaquifer transport

  18. Autonomous Planning and Replanning for Mine-Sweeping Unmanned Underwater Vehicles

    Science.gov (United States)

    Gaines, Daniel M.

    2010-01-01

    This software generates high-quality plans for carrying out mine-sweeping activities under resource constraints. The autonomous planning and replanning system for unmanned underwater vehicles (UUVs) takes as input a set of prioritized mine-sweep regions, and a specification of available UUV resources including available battery energy, data storage, and time available for accomplishing the mission. Mine-sweep areas vary in location, size of area to be swept, and importance of the region. The planner also works with a model of the UUV, as well as a model of the power consumption of the vehicle when idle and when moving.

  19. Fast sweeping method for the factored eikonal equation

    Science.gov (United States)

    Fomel, Sergey; Luo, Songting; Zhao, Hongkai

    2009-09-01

    We develop a fast sweeping method for the factored eikonal equation. By decomposing the solution of a general eikonal equation as the product of two factors: the first factor is the solution to a simple eikonal equation (such as distance) or a previously computed solution to an approximate eikonal equation. The second factor is a necessary modification/correction. Appropriate discretization and a fast sweeping strategy are designed for the equation of the correction part. The key idea is to enforce the causality of the original eikonal equation during the Gauss-Seidel iterations. Using extensive numerical examples we demonstrate that (1) the convergence behavior of the fast sweeping method for the factored eikonal equation is the same as for the original eikonal equation, i.e., the number of iterations for the Gauss-Seidel iterations is independent of the mesh size, (2) the numerical solution from the factored eikonal equation is more accurate than the numerical solution directly computed from the original eikonal equation, especially for point sources.

  20. Performance Comparison of Sweeping/Steady Jet Actuators

    Science.gov (United States)

    Hirsch, Damian; Mercier, Justin; Noca, Flavio; Gharib, Morteza

    2015-11-01

    Flow control through the use of steady jet actuators has been used on various aircraft models since the late 1950's. However, the focus of recent studies has shifted towards the use of sweeping jets (fluidic oscillators) rather than steady jet actuators. In this work, experiments using various jet actuator designs were conducted at GALCIT's Lucas Wind Tunnel on a NACA 0012 vertical tail model similar to that of the Boeing 767 vertical stabilizer at Reynolds numbers ranging from 0.5 to 1.2 million. The rudder angle was fixed at 20 degrees. A total of 32 jet actuators were installed along the wingspan perpendicular to the trailing edge and the rudder shoulder of the vertical stabilizer. It is known that these types of flow control prevent separation. However, the goal of this work is to compare different jet designs and evaluate their performance. Parameters such as the number of actuators, their volumetric flow, and the wind tunnel speed were varied. The lift generation capabilities of steady and sweeping jet actuators were then compared. Another set of experiments was conducted to compare a new sweeping jet actuator design with one of the standard versions. Supported by Boeing.

  1. Flux-corrected transport principles, algorithms, and applications

    CERN Document Server

    Kuzmin, Dmitri; Turek, Stefan

    2005-01-01

    Addressing students and researchers as well as CFD practitioners, this book describes the state of the art in the development of high-resolution schemes based on the Flux-Corrected Transport (FCT) paradigm. Intended for readers who have a solid background in Computational Fluid Dynamics, the book begins with historical notes by J.P. Boris and D.L. Book. Review articles that follow describe recent advances in the design of FCT algorithms as well as various algorithmic aspects. The topics addressed in the book and its main highlights include: the derivation and analysis of classical FCT schemes with special emphasis on the underlying physical and mathematical constraints; flux limiting for hyperbolic systems; generalization of FCT to implicit time-stepping and finite element discretizations on unstructured meshes and its role as a subgrid scale model for Monotonically Integrated Large Eddy Simulation (MILES) of turbulent flows. The proposed enhancements of the FCT methodology also comprise the prelimiting and '...

  2. AUTOMATION OF CALCULATION ALGORITHMS FOR EFFICIENCY ESTIMATION OF TRANSPORT INFRASTRUCTURE DEVELOPMENT

    Directory of Open Access Journals (Sweden)

    Sergey Kharitonov

    2015-06-01

    Full Text Available Optimum transport infrastructure usage is an important aspect of the development of the national economy of the Russian Federation. Thus, development of instruments for assessing the efficiency of infrastructure is impossible without constant monitoring of a number of significant indicators. This work is devoted to the selection of indicators and the method of their calculation in relation to the transport subsystem as airport infrastructure. The work also reflects aspects of the evaluation of the possibilities of algorithmic computational mechanisms to improve the tools of public administration transport subsystems.

  3. Analyser of sweeping electron beam

    International Nuclear Information System (INIS)

    Strasser, A.

    1993-01-01

    The electron beam analyser has an array of conductors that can be positioned in the field of the sweeping beam, an electronic signal treatment system for the analysis of the signals generated in the conductors by the incident electrons and a display for the different characteristics of the electron beam

  4. Connecting the failure of K-theory inside and above vegetation canopies and ejection-sweep cycles by a large eddy simulation

    International Nuclear Information System (INIS)

    Banerjee, Tirtha; De Roo, Frederik; Mauder, Matthias

    2017-01-01

    Parameterizations of biosphere-atmosphere interaction processes in climate models and other hydrological applications require characterization of turbulent transport of momentum and scalars between vegetation canopies and the atmosphere, which is often modeled using a turbulent analogy to molecular diffusion processes. However, simple flux-gradient approaches (K-theory) fail for canopy turbulence. One cause is turbulent transport by large coherent eddies at the canopy scale, which can be linked to sweep-ejection events, and bear signatures of non-local organized eddy motions. K-theory, that parameterizes the turbulent flux or stress proportional to the local concentration or velocity gradient, fails to account for these non-local organized motions. The connection to sweep-ejection cycles and the local turbulent flux can be traced back to the turbulence triple moment (C ′ W ′ W ′ )-bar. In this work, we use large-eddy simulation to investigate the diagnostic connection between the failure of K-theory and sweep-ejection motions. Analyzed schemes are quadrant analysis (QA) and a complete and incomplete cumulant expansion (CEM and ICEM) method. The latter approaches introduce a turbulence timescale in the modeling. Furthermore, we find that the momentum flux needs a different formulation for the turbulence timescale than the sensible heat flux. In conclusion, accounting for buoyancy in stratified conditions is also deemed to be important in addition to accounting for non-local events to predict the correct momentum or scalar fluxes.

  5. Mitigation of divertor heat loads by strike point sweeping in high power JET discharges

    Science.gov (United States)

    Silburn, S. A.; Matthews, G. F.; Challis, C. D.; Frigione, D.; Graves, J. P.; Mantsinen, M. J.; Belonohy, E.; Hobirk, J.; Iglesias, D.; Keeling, D. L.; King, D.; Kirov, K.; Lennholm, M.; Lomas, P. J.; Moradi, S.; Sips, A. C. C.; Tsalas, M.; Contributors, JET

    2017-12-01

    Deliberate periodic movement (sweeping) of the high heat flux divertor strike lines in tokamak plasmas can be used to manage the heat fluxes experienced by exhaust handling plasma facing components, by spreading the heat loads over a larger surface area. Sweeping has recently been adopted as a routine part of the main high performance plasma configurations used on JET, and has enabled pulses with 30 MW plasma heating power and 10 MW radiation to run for 5 s without overheating the divertor tiles. We present analysis of the effectiveness of sweeping for divertor temperature control on JET, using infrared camera data and comparison with a simple 2D heat diffusion model. Around 50% reduction in tile temperature rise is obtained with 5.4 cm sweeping compared to the un-swept case, and the temperature reduction is found to scale slower than linearly with sweeping amplitude in both experiments and modelling. Compatibility of sweeping with high fusion performance is demonstrated, and effects of sweeping on the edge-localised mode behaviour of the plasma are reported and discussed. The prospects of using sweeping in future JET experiments with up to 40 MW heating power are investigated using a model validated against existing experimental data.

  6. Mitigation of divertor heat loads by strike point sweeping in high power JET discharges

    International Nuclear Information System (INIS)

    Silburn, S A; Matthews, G F; Challis, C D; Belonohy, E; Iglesias, D; Keeling, D L; King, D; Kirov, K; Lomas, P J; Frigione, D; Graves, J P; Mantsinen, M J; Hobirk, J; Lennholm, M; Moradi, S; Sips, A C C; Tsalas, M

    2017-01-01

    Deliberate periodic movement (sweeping) of the high heat flux divertor strike lines in tokamak plasmas can be used to manage the heat fluxes experienced by exhaust handling plasma facing components, by spreading the heat loads over a larger surface area. Sweeping has recently been adopted as a routine part of the main high performance plasma configurations used on JET, and has enabled pulses with 30 MW plasma heating power and 10 MW radiation to run for 5 s without overheating the divertor tiles. We present analysis of the effectiveness of sweeping for divertor temperature control on JET, using infrared camera data and comparison with a simple 2D heat diffusion model. Around 50% reduction in tile temperature rise is obtained with 5.4 cm sweeping compared to the un-swept case, and the temperature reduction is found to scale slower than linearly with sweeping amplitude in both experiments and modelling. Compatibility of sweeping with high fusion performance is demonstrated, and effects of sweeping on the edge-localised mode behaviour of the plasma are reported and discussed. The prospects of using sweeping in future JET experiments with up to 40 MW heating power are investigated using a model validated against existing experimental data. (paper)

  7. A new method for calculating volumetric sweeps efficiency using streamline simulation concepts

    International Nuclear Information System (INIS)

    Hidrobo, E A

    2000-01-01

    One of the purposes of reservoir engineering is to quantify the volumetric sweep efficiency for optimizing reservoir management decisions. The estimation of this parameter has always been a difficult task. Until now, sweep efficiency correlations and calculations have been limited to mostly homogeneous 2-D cases. Calculating volumetric sweep efficiency in a 3-D heterogeneous reservoir becomes difficult due to inherent complexity of multiple layers and arbitrary well configurations. In this paper, a new method for computing volumetric sweep efficiency for any arbitrary heterogeneity and well configuration is presented. The proposed method is based on Datta-Gupta and King's formulation of streamline time-of-flight (1995). Given the fact that the time-of-flight reflects the fluid front propagation at various times, then the connectivity in the time-of-flight represents a direct measure of the volumetric sweep efficiency. The proposed approach has been applied to synthetic as well as field examples. Synthetic examples are used to validate the volumetric sweep efficiency calculations using the streamline time-of-flight connectivity criterion by comparison with analytic solutions and published correlations. The field example, which illustrates the feasibility of the approach for large-scale field applications, is from the north Robertson unit, a low permeability carbonate reservoir in west Texas

  8. Surfaces Relief Profilometry of Solid Objects by Sweeping of a Laser Line

    Science.gov (United States)

    Salas-Peimbert, Didia P.; Trujillo-Schiaffino, Gerardo; Mendoza-Villegas, Paloma G.; Ojeda-González, Daniel; Almazán-Cuellar, Saúl; Corral-Martínez, Luis F.

    2008-04-01

    This paper describes the development of a laser system for the digitalization and three-dimensional reconstruction of solid objects. The first step consists of applying on the object a linear sweeping of a thin laser line using a laser diode with 635 nm and 5 mW, a motorized stage for linear displacement of 138 mm, and a controller with RS232 interface. The next step consists of capturing and transmitting the image of the deformed line on the object to a computer. For this step was used a monochrome camera CCD, and an image acquisition board. The last step consists of the three-dimensional reconstruction of the solid object. All the corresponding algorithms were implemented using the programming language LabVIEW.

  9. Estimating the solute transport parameters of the spatial fractional advection-dispersion equation using Bees Algorithm.

    Science.gov (United States)

    Mehdinejadiani, Behrouz

    2017-08-01

    This study represents the first attempt to estimate the solute transport parameters of the spatial fractional advection-dispersion equation using Bees Algorithm. The numerical studies as well as the experimental studies were performed to certify the integrity of Bees Algorithm. The experimental ones were conducted in a sandbox for homogeneous and heterogeneous soils. A detailed comparative study was carried out between the results obtained from Bees Algorithm and those from Genetic Algorithm and LSQNONLIN routines in FracFit toolbox. The results indicated that, in general, the Bees Algorithm much more accurately appraised the sFADE parameters in comparison with Genetic Algorithm and LSQNONLIN, especially in the heterogeneous soil and for α values near to 1 in the numerical study. Also, the results obtained from Bees Algorithm were more reliable than those from Genetic Algorithm. The Bees Algorithm showed the relative similar performances for all cases, while the Genetic Algorithm and the LSQNONLIN yielded different performances for various cases. The performance of LSQNONLIN strongly depends on the initial guess values so that, compared to the Genetic Algorithm, it can more accurately estimate the sFADE parameters by taking into consideration the suitable initial guess values. To sum up, the Bees Algorithm was found to be very simple, robust and accurate approach to estimate the transport parameters of the spatial fractional advection-dispersion equation. Copyright © 2017 Elsevier B.V. All rights reserved.

  10. Estimating the solute transport parameters of the spatial fractional advection-dispersion equation using Bees Algorithm

    Science.gov (United States)

    Mehdinejadiani, Behrouz

    2017-08-01

    This study represents the first attempt to estimate the solute transport parameters of the spatial fractional advection-dispersion equation using Bees Algorithm. The numerical studies as well as the experimental studies were performed to certify the integrity of Bees Algorithm. The experimental ones were conducted in a sandbox for homogeneous and heterogeneous soils. A detailed comparative study was carried out between the results obtained from Bees Algorithm and those from Genetic Algorithm and LSQNONLIN routines in FracFit toolbox. The results indicated that, in general, the Bees Algorithm much more accurately appraised the sFADE parameters in comparison with Genetic Algorithm and LSQNONLIN, especially in the heterogeneous soil and for α values near to 1 in the numerical study. Also, the results obtained from Bees Algorithm were more reliable than those from Genetic Algorithm. The Bees Algorithm showed the relative similar performances for all cases, while the Genetic Algorithm and the LSQNONLIN yielded different performances for various cases. The performance of LSQNONLIN strongly depends on the initial guess values so that, compared to the Genetic Algorithm, it can more accurately estimate the sFADE parameters by taking into consideration the suitable initial guess values. To sum up, the Bees Algorithm was found to be very simple, robust and accurate approach to estimate the transport parameters of the spatial fractional advection-dispersion equation.

  11. Alternate mutation based artificial immune algorithm for step fixed charge transportation problem

    Directory of Open Access Journals (Sweden)

    Mahmoud Moustafa El-Sherbiny

    2012-07-01

    Full Text Available Step fixed charge transportation problem (SFCTP is considered as a special version of the fixed-charge transportation problem (FCTP. In SFCTP, the fixed cost is incurred for every route that is used in the solution and is proportional to the amount shipped. This cost structure causes the value of the objective function to behave like a step function. Both FCTP and SFCTP are considered to be NP-hard problems. While a lot of research has been carried out concerning FCTP, not much has been done concerning SFCTP. This paper introduces an alternate Mutation based Artificial Immune (MAI algorithm for solving SFCTPs. The proposed MAI algorithm solves both balanced and unbalanced SFCTP without introducing a dummy supplier or a dummy customer. In MAI algorithm a coding schema is designed and procedures are developed for decoding such schema and shipping units. MAI algorithm guarantees the feasibility of all the generated solutions. Due to the significant role of mutation function on the MAI algorithm’s quality, 16 mutation functions are presented and their performances are compared to select the best one. For this purpose, forty problems with different sizes have been generated at random and then a robust calibration is applied using the relative percentage deviation (RPD method. Through two illustrative problems of different sizes the performance of the MAI algorithm has been compared with most recent methods.

  12. A 2D/1D coupling neutron transport method based on the matrix MOC and NEM methods

    International Nuclear Information System (INIS)

    Zhang, H.; Zheng, Y.; Wu, H.; Cao, L.

    2013-01-01

    A new 2D/1D coupling method based on the matrix MOC method (MMOC) and nodal expansion method (NEM) is proposed for solving the three-dimensional heterogeneous neutron transport problem. The MMOC method, used for radial two-dimensional calculation, constructs a response matrix between source and flux with only one sweep and then solves the linear system by using the restarted GMRES algorithm instead of the traditional trajectory sweeping process during within-group iteration for angular flux update. Long characteristics are generated by using the customization of commercial software AutoCAD. A one-dimensional diffusion calculation is carried out in the axial direction by employing the NEM method. The 2D and ID solutions are coupled through the transverse leakage items. The 3D CMFD method is used to ensure the global neutron balance and adjust the different convergence properties of the radial and axial solvers. A computational code is developed based on these theories. Two benchmarks are calculated to verify the coupling method and the code. It is observed that the corresponding numerical results agree well with references, which indicates that the new method is capable of solving the 3D heterogeneous neutron transport problem directly. (authors)

  13. A 2D/1D coupling neutron transport method based on the matrix MOC and NEM methods

    Energy Technology Data Exchange (ETDEWEB)

    Zhang, H.; Zheng, Y.; Wu, H.; Cao, L. [School of Nuclear Science and Technology, Xi' an Jiaotong University, No. 28, Xianning West Road, Xi' an, Shaanxi 710049 (China)

    2013-07-01

    A new 2D/1D coupling method based on the matrix MOC method (MMOC) and nodal expansion method (NEM) is proposed for solving the three-dimensional heterogeneous neutron transport problem. The MMOC method, used for radial two-dimensional calculation, constructs a response matrix between source and flux with only one sweep and then solves the linear system by using the restarted GMRES algorithm instead of the traditional trajectory sweeping process during within-group iteration for angular flux update. Long characteristics are generated by using the customization of commercial software AutoCAD. A one-dimensional diffusion calculation is carried out in the axial direction by employing the NEM method. The 2D and ID solutions are coupled through the transverse leakage items. The 3D CMFD method is used to ensure the global neutron balance and adjust the different convergence properties of the radial and axial solvers. A computational code is developed based on these theories. Two benchmarks are calculated to verify the coupling method and the code. It is observed that the corresponding numerical results agree well with references, which indicates that the new method is capable of solving the 3D heterogeneous neutron transport problem directly. (authors)

  14. Massively parallel performance of neutron transport response matrix algorithms

    International Nuclear Information System (INIS)

    Hanebutte, U.R.; Lewis, E.E.

    1993-01-01

    Massively parallel red/black response matrix algorithms for the solution of within-group neutron transport problems are implemented on the Connection Machines-2, 200 and 5. The response matrices are dericed from the diamond-differences and linear-linear nodal discrete ordinate and variational nodal P 3 approximations. The unaccelerated performance of the iterative procedure is examined relative to the maximum rated performances of the machines. The effects of processor partitions size, of virtual processor ratio and of problems size are examined in detail. For the red/black algorithm, the ratio of inter-node communication to computing times is found to be quite small, normally of the order of ten percent or less. Performance increases with problems size and with virtual processor ratio, within the memeory per physical processor limitation. Algorithm adaptation to courser grain machines is straight-forward, with total computing time being virtually inversely proportional to the number of physical processors. (orig.)

  15. Application of an Intelligent Fuzzy Regression Algorithm in Road Freight Transportation Modeling

    Directory of Open Access Journals (Sweden)

    Pooya Najaf

    2013-07-01

    Full Text Available Road freight transportation between provinces of a country has an important effect on the traffic flow of intercity transportation networks. Therefore, an accurate estimation of the road freight transportation for provinces of a country is so crucial to improve the rural traffic operation in a large scale management. Accordingly, the focused case study database in this research is the information related to Iran’s provinces in the year 2008. Correlation between road freight transportation with variables such as transport cost and distance, population, average household income and Gross Domestic Product (GDP of each province is calculated. Results clarify that the population is the most effective factor in the prediction of provinces’ transported freight. Linear Regression Model (LRM is calibrated based on the population variable, and afterwards Fuzzy Regression Algorithm (FRA is generated on the basis of the LRM. The proposed FRA is an intelligent modified algorithm with an accurate prediction and fitting ability. This methodology can be significantly useful in macro-level planning problems where decreasing prediction error values is one of the most important concerns for decision makers. In addition, Back-Propagation Neural Network (BPNN is developed to evaluate the prediction capability of the models and to be compared with FRA. According to the final results, the modified FRA estimates road freight transportation values more accurately than the BPNN and LRM. Finally, in order to predict the road freight transportation values, the reliability of the calibrated models is analyzed using the information of the year 2009. Results show higher reliability for the proposed modified FRA.

  16. Soft Sweeps Are the Dominant Mode of Adaptation in the Human Genome.

    Science.gov (United States)

    Schrider, Daniel R; Kern, Andrew D

    2017-08-01

    The degree to which adaptation in recent human evolution shapes genetic variation remains controversial. This is in part due to the limited evidence in humans for classic "hard selective sweeps", wherein a novel beneficial mutation rapidly sweeps through a population to fixation. However, positive selection may often proceed via "soft sweeps" acting on mutations already present within a population. Here, we examine recent positive selection across six human populations using a powerful machine learning approach that is sensitive to both hard and soft sweeps. We found evidence that soft sweeps are widespread and account for the vast majority of recent human adaptation. Surprisingly, our results also suggest that linked positive selection affects patterns of variation across much of the genome, and may increase the frequencies of deleterious mutations. Our results also reveal insights into the role of sexual selection, cancer risk, and central nervous system development in recent human evolution. © The Author 2017. Published by Oxford University Press on behalf of the Society for Molecular Biology and Evolution.

  17. Single-sweep spectral analysis of contact heat evoked potentials

    DEFF Research Database (Denmark)

    Hansen, Tine M; Graversen, Carina; Frøkjaer, Jens B

    2015-01-01

    AIMS: The cortical response to nociceptive thermal stimuli recorded as contact heat evoked potentials (CHEPs) may be altered by morphine. However, previous studies have averaged CHEPs over multiple stimuli, which are confounded by jitter between sweeps. Thus, the aim was to assess single-sweep ch......AIMS: The cortical response to nociceptive thermal stimuli recorded as contact heat evoked potentials (CHEPs) may be altered by morphine. However, previous studies have averaged CHEPs over multiple stimuli, which are confounded by jitter between sweeps. Thus, the aim was to assess single...... by 13% (P = 0.04) and 9% (P = 0.007), while the beta and gamma bands were increased by 10% (P = 0.006) and 24% (P = 0.04). CONCLUSION: The decreases in the delta and theta band are suggested to represent a decrease in the pain specific morphology of the CHEPs, which indicates a diminished pain response...

  18. Determining Plane-Sweep Sampling Points in Image Space Using the Cross-Ratio for Image-Based Depth Estimation

    Science.gov (United States)

    Ruf, B.; Erdnuess, B.; Weinmann, M.

    2017-08-01

    With the emergence of small consumer Unmanned Aerial Vehicles (UAVs), the importance and interest of image-based depth estimation and model generation from aerial images has greatly increased in the photogrammetric society. In our work, we focus on algorithms that allow an online image-based dense depth estimation from video sequences, which enables the direct and live structural analysis of the depicted scene. Therefore, we use a multi-view plane-sweep algorithm with a semi-global matching (SGM) optimization which is parallelized for general purpose computation on a GPU (GPGPU), reaching sufficient performance to keep up with the key-frames of input sequences. One important aspect to reach good performance is the way to sample the scene space, creating plane hypotheses. A small step size between consecutive planes, which is needed to reconstruct details in the near vicinity of the camera may lead to ambiguities in distant regions, due to the perspective projection of the camera. Furthermore, an equidistant sampling with a small step size produces a large number of plane hypotheses, leading to high computational effort. To overcome these problems, we present a novel methodology to directly determine the sampling points of plane-sweep algorithms in image space. The use of the perspective invariant cross-ratio allows us to derive the location of the sampling planes directly from the image data. With this, we efficiently sample the scene space, achieving higher sampling density in areas which are close to the camera and a lower density in distant regions. We evaluate our approach on a synthetic benchmark dataset for quantitative evaluation and on a real-image dataset consisting of aerial imagery. The experiments reveal that an inverse sampling achieves equal and better results than a linear sampling, with less sampling points and thus less runtime. Our algorithm allows an online computation of depth maps for subsequences of five frames, provided that the relative

  19. DETERMINING PLANE-SWEEP SAMPLING POINTS IN IMAGE SPACE USING THE CROSS-RATIO FOR IMAGE-BASED DEPTH ESTIMATION

    Directory of Open Access Journals (Sweden)

    B. Ruf

    2017-08-01

    Full Text Available With the emergence of small consumer Unmanned Aerial Vehicles (UAVs, the importance and interest of image-based depth estimation and model generation from aerial images has greatly increased in the photogrammetric society. In our work, we focus on algorithms that allow an online image-based dense depth estimation from video sequences, which enables the direct and live structural analysis of the depicted scene. Therefore, we use a multi-view plane-sweep algorithm with a semi-global matching (SGM optimization which is parallelized for general purpose computation on a GPU (GPGPU, reaching sufficient performance to keep up with the key-frames of input sequences. One important aspect to reach good performance is the way to sample the scene space, creating plane hypotheses. A small step size between consecutive planes, which is needed to reconstruct details in the near vicinity of the camera may lead to ambiguities in distant regions, due to the perspective projection of the camera. Furthermore, an equidistant sampling with a small step size produces a large number of plane hypotheses, leading to high computational effort. To overcome these problems, we present a novel methodology to directly determine the sampling points of plane-sweep algorithms in image space. The use of the perspective invariant cross-ratio allows us to derive the location of the sampling planes directly from the image data. With this, we efficiently sample the scene space, achieving higher sampling density in areas which are close to the camera and a lower density in distant regions. We evaluate our approach on a synthetic benchmark dataset for quantitative evaluation and on a real-image dataset consisting of aerial imagery. The experiments reveal that an inverse sampling achieves equal and better results than a linear sampling, with less sampling points and thus less runtime. Our algorithm allows an online computation of depth maps for subsequences of five frames, provided that

  20. A Sweeping Jet Application on a High Reynolds Number Semispan Supercritical Wing Configuration

    Science.gov (United States)

    Jones, Gregory S.; Milholen, William E., II; Chan, David T.; Melton, Latunia; Goodliff, Scott L.; Cagle, C. Mark

    2017-01-01

    The FAST-MAC circulation control model was modified to test an array of unsteady sweeping-jet actuators at realistic flight Reynolds numbers in the National Transonic Facility at the NASA Langley Research Center. Two types of sweeping jet actuators were fabricated using rapid prototype techniques, and directed over a 15% chord simple-hinged flap. The model was configured for low-speed high-lift testing with flap deflections of 30 deg and 60 deg, and a transonic cruise configuration having a 0 deg flap deflection. For the 30 deg flap high-lift configuration, the sweeping jets achieved comparable lift performance in the separation control regime, while reducing the mass flow by 54% as compared to steady blowing. The sweeping jets however were not effective for the 60 deg flap. For the transonic cruise configuration, the sweeping jets reduced the drag by 3.3% at an off-design condition. The drag reduction for the design lift coefficient for the sweeping jets offer is only half the drag reduction shown for the steady blowing case (6.5%), but accomplished this with a 74% reduction in mass flow.

  1. Acupuncture and/or sweeping of the fetal membranes before induction of labor

    DEFF Research Database (Denmark)

    Andersen, Bodil Birgitte; Knudsen, Birthe; Lyndrup, Jens

    2013-01-01

    To evaluate the efficacy of acupuncture, and sweeping of the fetal membranes, as methods for induction of labor.......To evaluate the efficacy of acupuncture, and sweeping of the fetal membranes, as methods for induction of labor....

  2. Analysis of sweeping heat loads on divertor plate materials

    International Nuclear Information System (INIS)

    Hassanein, A.

    1991-01-01

    The heat flux on the divertor plate of a fusion reactor is probably one of the most limiting constraints on its lifetime. The current heat flux profile on the outer divertor plate of a device like ITER is highly peaked with narrow profile. The peak heat flux can be as high as 30--40 MW/m 2 with full width at half maximum (FWHM) is in the order of a few centimeters. Sweeping the separatrix along the divertor plate is one of the options proposed to reduce the thermomechanical effects of this highly peaked narrow profile distribution. The effectiveness of the sweeping process is investigated parametrically for various design values. The optimum sweeping parameters of a particular heat load will depend on the design of the divertor plate as well as on the profile of such a heat load. In general, moving a highly peaked heat load results in substantial reduction of the thermomechanical effects on the divertor plate. 3 refs., 8 figs

  3. Resolution of the steady state transport equation for Lagrangian geometry with cylindrical symmetry

    International Nuclear Information System (INIS)

    Samba, G.

    1983-05-01

    The purpose of this work is to solve the steady state transport equation for (r, z) geometries given by hydrodynamics calculations. The discontinuous finite element method for the space variables (r, z) provides a stable scheme which satisfies the particle balance equation. We are able to sweep cells for each direction over the mesh to have an explicit scheme. The graph theory provides a very efficient algorithm to compute this ordering array. Previously, we must divide all the quadrilaterals into two triangles to get only convex cells. Thus, we get a fast, vectorized calculation which gives a good accuracy on very distorted meshes [fr

  4. Second order evolution inclusions governed by sweeping process in Banach spaces

    Directory of Open Access Journals (Sweden)

    A. G. Ibrahim

    2009-11-01

    Full Text Available In this paper we prove two existence theorems concerning the existence of solutions for second order evolution inclusions governed by sweeping process with closed convex sets depending on time and state in Banach spaces. This work extends some recent existence theorems cncerning sweeping process from Hilbert spaces to Banach spaces.

  5. Numerical simulation of ion transport membrane reactors: Oxygen permeation and transport and fuel conversion

    KAUST Repository

    Hong, Jongsup

    2012-07-01

    Ion transport membrane (ITM) based reactors have been suggested as a novel technology for several applications including fuel reforming and oxy-fuel combustion, which integrates air separation and fuel conversion while reducing complexity and the associated energy penalty. To utilize this technology more effectively, it is necessary to develop a better understanding of the fundamental processes of oxygen transport and fuel conversion in the immediate vicinity of the membrane. In this paper, a numerical model that spatially resolves the gas flow, transport and reactions is presented. The model incorporates detailed gas phase chemistry and transport. The model is used to express the oxygen permeation flux in terms of the oxygen concentrations at the membrane surface given data on the bulk concentration, which is necessary for cases when mass transfer limitations on the permeate side are important and for reactive flow modeling. The simulation results show the dependence of oxygen transport and fuel conversion on the geometry and flow parameters including the membrane temperature, feed and sweep gas flow, oxygen concentration in the feed and fuel concentration in the sweep gas. © 2012 Elsevier B.V.

  6. Comparison of genetic algorithm and imperialist competitive algorithms in predicting bed load transport in clean pipe.

    Science.gov (United States)

    Ebtehaj, Isa; Bonakdari, Hossein

    2014-01-01

    The existence of sediments in wastewater greatly affects the performance of the sewer and wastewater transmission systems. Increased sedimentation in wastewater collection systems causes problems such as reduced transmission capacity and early combined sewer overflow. The article reviews the performance of the genetic algorithm (GA) and imperialist competitive algorithm (ICA) in minimizing the target function (mean square error of observed and predicted Froude number). To study the impact of bed load transport parameters, using four non-dimensional groups, six different models have been presented. Moreover, the roulette wheel selection method is used to select the parents. The ICA with root mean square error (RMSE) = 0.007, mean absolute percentage error (MAPE) = 3.5% show better results than GA (RMSE = 0.007, MAPE = 5.6%) for the selected model. All six models return better results than the GA. Also, the results of these two algorithms were compared with multi-layer perceptron and existing equations.

  7. An Experiment of Robust Parallel Algorithm for the Eigenvalue problem of a Multigroup Neutron Diffusion based on modified FETI-DP

    Energy Technology Data Exchange (ETDEWEB)

    Chang, Jonghwa [Korea Atomic Energy Research Institute, Daejeon (Korea, Republic of)

    2014-05-15

    Parallelization of Monte Carlo simulation is widely adpoted. There are also several parallel algorithms developed for the SN transport theory using the parallel wave sweeping algorithm and for the CPM using parallel ray tracing. For practical purpose of reactor physics application, the thermal feedback and burnup effects on the multigroup cross section should be considered. In this respect, the domain decomposition method(DDM) is suitable for distributing the expensive cross section calculation work. Parallel transport code and diffusion code based on the Raviart-Thomas mixed finite element method was developed. However most of the developed methods rely on the heuristic convergence of flux and current at the domain interfaces. Convergence was not attained in some cases. Mechanical stress computation community has also work on the DDM to solve the stress-strain equation using the finite element methods. The most successful domain decomposition method in terms of robustness is FETI-DP. We have modified the original FETI-DP to solve the eigenvalue problem for the multigroup diffusion problem in this study.

  8. R2d2 Drives Selfish Sweeps in the House Mouse.

    Science.gov (United States)

    Didion, John P; Morgan, Andrew P; Yadgary, Liran; Bell, Timothy A; McMullan, Rachel C; Ortiz de Solorzano, Lydia; Britton-Davidian, Janice; Bult, Carol J; Campbell, Karl J; Castiglia, Riccardo; Ching, Yung-Hao; Chunco, Amanda J; Crowley, James J; Chesler, Elissa J; Förster, Daniel W; French, John E; Gabriel, Sofia I; Gatti, Daniel M; Garland, Theodore; Giagia-Athanasopoulou, Eva B; Giménez, Mabel D; Grize, Sofia A; Gündüz, İslam; Holmes, Andrew; Hauffe, Heidi C; Herman, Jeremy S; Holt, James M; Hua, Kunjie; Jolley, Wesley J; Lindholm, Anna K; López-Fuster, María J; Mitsainas, George; da Luz Mathias, Maria; McMillan, Leonard; Ramalhinho, Maria da Graça Morgado; Rehermann, Barbara; Rosshart, Stephan P; Searle, Jeremy B; Shiao, Meng-Shin; Solano, Emanuela; Svenson, Karen L; Thomas-Laemont, Patricia; Threadgill, David W; Ventura, Jacint; Weinstock, George M; Pomp, Daniel; Churchill, Gary A; Pardo-Manuel de Villena, Fernando

    2016-06-01

    A selective sweep is the result of strong positive selection driving newly occurring or standing genetic variants to fixation, and can dramatically alter the pattern and distribution of allelic diversity in a population. Population-level sequencing data have enabled discoveries of selective sweeps associated with genes involved in recent adaptations in many species. In contrast, much debate but little evidence addresses whether "selfish" genes are capable of fixation-thereby leaving signatures identical to classical selective sweeps-despite being neutral or deleterious to organismal fitness. We previously described R2d2, a large copy-number variant that causes nonrandom segregation of mouse Chromosome 2 in females due to meiotic drive. Here we show population-genetic data consistent with a selfish sweep driven by alleles of R2d2 with high copy number (R2d2(HC)) in natural populations. We replicate this finding in multiple closed breeding populations from six outbred backgrounds segregating for R2d2 alleles. We find that R2d2(HC) rapidly increases in frequency, and in most cases becomes fixed in significantly fewer generations than can be explained by genetic drift. R2d2(HC) is also associated with significantly reduced litter sizes in heterozygous mothers, making it a true selfish allele. Our data provide direct evidence of populations actively undergoing selfish sweeps, and demonstrate that meiotic drive can rapidly alter the genomic landscape in favor of mutations with neutral or even negative effects on overall Darwinian fitness. Further study will reveal the incidence of selfish sweeps, and will elucidate the relative contributions of selfish genes, adaptation and genetic drift to evolution. © The Author 2016. Published by Oxford University Press on behalf of the Society for Molecular Biology and Evolution.

  9. Oxide vapor distribution from a high-frequency sweep e-beam system

    Science.gov (United States)

    Chow, R.; Tassano, P. L.; Tsujimoto, N.

    1995-03-01

    Oxide vapor distributions have been determined as a function of operating parameters of a high frequency sweep e-beam source combined with a programmable sweep controller. We will show which parameters are significant, the parameters that yield the broadest oxide deposition distribution, and the procedure used to arrive at these conclusions. A design-of-experimental strategy was used with five operating parameters: evaporation rate, sweep speed, sweep pattern (pre-programmed), phase speed (azimuthal rotation of the pattern), profile (dwell time as a function of radial position). A design was chosen that would show which of the parameters and parameter pairs have a statistically significant effect on the vapor distribution. Witness flats were placed symmetrically across a 25 inches diameter platen. The stationary platen was centered 24 inches above the e-gun crucible. An oxide material was evaporated under 27 different conditions. Thickness measurements were made with a stylus profilometer. The information will enable users of the high frequency e-gun systems to optimally locate the source in a vacuum system and understand which parameters have a major effect on the vapor distribution.

  10. Variants of Moreau's sweeping process

    International Nuclear Information System (INIS)

    Siddiqi, A.H.; Manchanda, P.

    2001-07-01

    In this paper we prove the existence and uniqueness of two variants of Moreau's sweeping process -u'(t) is an element of Nc (t) (u(t)), where in one variant we replace u(t) by u'(t) in the right-hand side of the inclusion and in the second variant u'(t) and u(t) are respectively replaced by u''(t) and u'(t). (author)

  11. Evaluation of two sweeping methods for estimating the number of immature Aedes aegypti (Diptera: Culicidae in large containers

    Directory of Open Access Journals (Sweden)

    Margareth Regina Dibo

    2013-07-01

    Full Text Available Introduction Here, we evaluated sweeping methods used to estimate the number of immature Aedes aegypti in large containers. Methods III/IV instars and pupae at a 9:1 ratio were placed in three types of containers with, each one with three different water levels. Two sweeping methods were tested: water-surface sweeping and five-sweep netting. The data were analyzed using linear regression. Results The five-sweep netting technique was more suitable for drums and water-tanks, while the water-surface sweeping method provided the best results for swimming pools. Conclusions Both sweeping methods are useful tools in epidemiological surveillance programs for the control of Aedes aegypti.

  12. Enhancing the mathematical properties of new haplotype homozygosity statistics for the detection of selective sweeps.

    Science.gov (United States)

    Garud, Nandita R; Rosenberg, Noah A

    2015-06-01

    Soft selective sweeps represent an important form of adaptation in which multiple haplotypes bearing adaptive alleles rise to high frequency. Most statistical methods for detecting selective sweeps from genetic polymorphism data, however, have focused on identifying hard selective sweeps in which a favored allele appears on a single haplotypic background; these methods might be underpowered to detect soft sweeps. Among exceptions is the set of haplotype homozygosity statistics introduced for the detection of soft sweeps by Garud et al. (2015). These statistics, examining frequencies of multiple haplotypes in relation to each other, include H12, a statistic designed to identify both hard and soft selective sweeps, and H2/H1, a statistic that conditional on high H12 values seeks to distinguish between hard and soft sweeps. A challenge in the use of H2/H1 is that its range depends on the associated value of H12, so that equal H2/H1 values might provide different levels of support for a soft sweep model at different values of H12. Here, we enhance the H12 and H2/H1 haplotype homozygosity statistics for selective sweep detection by deriving the upper bound on H2/H1 as a function of H12, thereby generating a statistic that normalizes H2/H1 to lie between 0 and 1. Through a reanalysis of resequencing data from inbred lines of Drosophila, we show that the enhanced statistic both strengthens interpretations obtained with the unnormalized statistic and leads to empirical insights that are less readily apparent without the normalization. Copyright © 2015 Elsevier Inc. All rights reserved.

  13. Self-Adjoint Angular Flux Equation for Coupled Electron-Photon Transport

    International Nuclear Information System (INIS)

    Liscum-Powell, J.L.; Lorence, L.J. Jr.; Morel, J.E.; Prinja, A.K.

    1999-01-01

    Recently, Morel and McGhee described an alternate second-order form of the transport equation called the self adjoint angular flux (SAAF) equation that has the angular flux as its unknown. The SAAF formulation has all the advantages of the traditional even- and odd-parity self-adjoint equations, with the added advantages that it yields the full angular flux when it is numerically solved, it is significantly easier to implement reflective and reflective-like boundary conditions, and in the appropriate form it can be solved in void regions. The SAAF equation has the disadvantage that the angular domain is the full unit sphere and, like the even- and odd- parity form, S n source iteration cannot be implemented using the standard sweeping algorithm. Also, problems arise in pure scattering media. Morel and McGhee demonstrated the efficacy of the SAAF formulation for neutral particle transport. Here we apply the SAAF formulation to coupled electron-photon transport problems using multigroup cross-sections from the CEPXS code and S n discretization

  14. Self-adjoint angular flux equation for coupled electron-photon transport

    International Nuclear Information System (INIS)

    Liscum-Powell, J.L.; Prinja, A.K.; Morel, J.E.; Lorence, L.J. Jr.

    1999-01-01

    Recently, Morel and McGhee described an alternate second-order form of the transport equation called the self-adjoint angular flux (SAAF) equation that has the angular flux as its unknown. The SAAF formulation has all the advantages of the traditional even- and odd-parity self-adjoint equations, with the added advantages that it yields the full angular flux when it is numerically solved, it is significantly easier to implement reflective and reflective-like boundary conditions, and in the appropriate form it can be solved in void regions. The SAAF equation has the disadvantage that the angular domain is the full unit sphere, and, like the even- and odd-parity form, S n source iteration cannot be implemented using the standard sweeping algorithm. Also, problems arise in pure scattering media. Morel and McGhee demonstrated the efficacy of the SAAF formulation for neutral particle transport. Here, the authors apply the SAAF formulation to coupled electron-photon transport problems using multigroup cross sections from the CEPXS code and S n discretization

  15. A beam sweeping system for the Fermilab antiproton production target

    International Nuclear Information System (INIS)

    Bieniosek, F.M.

    1993-08-01

    In the Main Injector era beam intensities high enough to damage the antiproton production target will be available. In order to continue to operate with a tightly-focused primary beam spot on the target, and thus maintain yield, it will be necessary to spread the hot spot on the target by use of a beam sweeping system. This report summarizes the requirements for such a system, and addresses the issues involved in the design of a sweeping system

  16. An Algorithm for the Mixed Transportation Network Design Problem.

    Science.gov (United States)

    Liu, Xinyu; Chen, Qun

    2016-01-01

    This paper proposes an optimization algorithm, the dimension-down iterative algorithm (DDIA), for solving a mixed transportation network design problem (MNDP), which is generally expressed as a mathematical programming with equilibrium constraint (MPEC). The upper level of the MNDP aims to optimize the network performance via both the expansion of the existing links and the addition of new candidate links, whereas the lower level is a traditional Wardrop user equilibrium (UE) problem. The idea of the proposed solution algorithm (DDIA) is to reduce the dimensions of the problem. A group of variables (discrete/continuous) is fixed to optimize another group of variables (continuous/discrete) alternately; then, the problem is transformed into solving a series of CNDPs (continuous network design problems) and DNDPs (discrete network design problems) repeatedly until the problem converges to the optimal solution. The advantage of the proposed algorithm is that its solution process is very simple and easy to apply. Numerical examples show that for the MNDP without budget constraint, the optimal solution can be found within a few iterations with DDIA. For the MNDP with budget constraint, however, the result depends on the selection of initial values, which leads to different optimal solutions (i.e., different local optimal solutions). Some thoughts are given on how to derive meaningful initial values, such as by considering the budgets of new and reconstruction projects separately.

  17. An Algorithm for the Mixed Transportation Network Design Problem.

    Directory of Open Access Journals (Sweden)

    Xinyu Liu

    Full Text Available This paper proposes an optimization algorithm, the dimension-down iterative algorithm (DDIA, for solving a mixed transportation network design problem (MNDP, which is generally expressed as a mathematical programming with equilibrium constraint (MPEC. The upper level of the MNDP aims to optimize the network performance via both the expansion of the existing links and the addition of new candidate links, whereas the lower level is a traditional Wardrop user equilibrium (UE problem. The idea of the proposed solution algorithm (DDIA is to reduce the dimensions of the problem. A group of variables (discrete/continuous is fixed to optimize another group of variables (continuous/discrete alternately; then, the problem is transformed into solving a series of CNDPs (continuous network design problems and DNDPs (discrete network design problems repeatedly until the problem converges to the optimal solution. The advantage of the proposed algorithm is that its solution process is very simple and easy to apply. Numerical examples show that for the MNDP without budget constraint, the optimal solution can be found within a few iterations with DDIA. For the MNDP with budget constraint, however, the result depends on the selection of initial values, which leads to different optimal solutions (i.e., different local optimal solutions. Some thoughts are given on how to derive meaningful initial values, such as by considering the budgets of new and reconstruction projects separately.

  18. Hemodynamic and oxygen transport patterns for outcome prediction, therapeutic goals, and clinical algorithms to improve outcome. Feasibility of artificial intelligence to customize algorithms.

    Science.gov (United States)

    Shoemaker, W C; Patil, R; Appel, P L; Kram, H B

    1992-11-01

    A generalized decision tree or clinical algorithm for treatment of high-risk elective surgical patients was developed from a physiologic model based on empirical data. First, a large data bank was used to do the following: (1) describe temporal hemodynamic and oxygen transport patterns that interrelate cardiac, pulmonary, and tissue perfusion functions in survivors and nonsurvivors; (2) define optimal therapeutic goals based on the supranormal oxygen transport values of high-risk postoperative survivors; (3) compare the relative effectiveness of alternative therapies in a wide variety of clinical and physiologic conditions; and (4) to develop criteria for titration of therapy to the endpoints of the supranormal optimal goals using cardiac index (CI), oxygen delivery (DO2), and oxygen consumption (VO2) as proxy outcome measures. Second, a general purpose algorithm was generated from these data and tested in preoperatively randomized clinical trials of high-risk surgical patients. Improved outcome was demonstrated with this generalized algorithm. The concept that the supranormal values represent compensations that have survival value has been corroborated by several other groups. We now propose a unique approach to refine the generalized algorithm to develop customized algorithms and individualized decision analysis for each patient's unique problems. The present article describes a preliminary evaluation of the feasibility of artificial intelligence techniques to accomplish individualized algorithms that may further improve patient care and outcome.

  19. HB-Line Dissolution of Glovebox Floor Sweepings

    International Nuclear Information System (INIS)

    Gray, J.H.

    1998-02-01

    Two candidate flowsheets for dissolving glovebox floor sweepings in the HB-Line Phase I geometrically favorable dissolver have been developed.Dissolving conditions tested and modified during the laboratory program were based on the current processing scheme for dissolving high-fired Pu-238 oxide in HB-Line. Subsequent adjustments made to the HB-Line flowsheet reflected differences in the dissolution behavior between high-fired Pu-238 oxide and the MgO sand/PuF 4 /PuO 2 mixture in glovebox floor sweepings. Although both candidate flowsheets involved two separate dissolving steps and resulted incomplete dissolution of all solids, the one selected for use in HB-Line will require fewer processing operations and resembles the initial flowsheet proposed for dissolving sand, slag, and crucible material in F-Canyon dissolvers. Complete dissolution of glovebox floor sweepings was accomplished in the laboratory by initially dissolving between 55 and 65 degree in a 14 molar nitric acid solution. Under these conditions, partial dissolution of PuF 4 and complete dissolution of PuO 2 and MgO sand were achieved in less than one hour. The presence of free fluoride in solution,uncomplexed by aluminum, was necessary for complete dissolution of the PuO 2 .The remaining PuF 4 dissolved following addition of aluminum nitrate nonahydrate (ANN) to complex the fluoride and heating between 75 and 85 degree C for an additional hour. Precipitation of magnesium and/or aluminum nitrates could occur before, during, and after transfer of product solutions. Both dilution and/or product solution temperature controls may be necessary to prevent precipitation of these salts. Corrosion of the dissolver should not be an issue during these dissolving operations. Corrosion is minimized when dissolving at 55-65 degree C for one to three hours at a maximum uncomplexed free fluoride concentration of 0.07 molar and by dissolving at 75-85 degree C at a one to one aluminum to fluoride mole ratio for another

  20. Detection and reconstruction of freeform sweeps

    KAUST Repository

    Barton, Michael

    2014-05-01

    We study the difficult problem of deciding if parts of a freeform surface can be generated, or approximately generated, by the motion of a planar profile through space. While this task is basic for understanding the geometry of shapes as well as highly relevant for manufacturing and building construction, previous approaches were confined to special cases like kinematic surfaces or "moulding" surfaces. The general case remained unsolved so far. We approach this problem by a combination of local and global methods: curve analysis with regard to "movability", curve comparison by common substring search in curvature plots, an exhaustive search through all planar cuts enhanced by quick rejection procedures, the ordering of candidate profiles and finally, global optimization. The main applications of our method are digital reconstruction of CAD models exhibiting sweep patches, and aiding in manufacturing freeform surfaces by pointing out those parts which can be approximated by sweeps. © 2014 The Author(s) Computer Graphics Forum © 2014 The Eurographics Association and John Wiley & Sons Ltd. Published by John Wiley & Sons Ltd.

  1. Selective sweeps of mitochondrial DNA can drive the evolution of uniparental inheritance.

    Science.gov (United States)

    Christie, Joshua R; Beekman, Madeleine

    2017-08-01

    Although the uniparental (or maternal) inheritance of mitochondrial DNA (mtDNA) is widespread, the reasons for its evolution remain unclear. Two main hypotheses have been proposed: selection against individuals containing different mtDNAs (heteroplasmy) and selection against "selfish" mtDNA mutations. Recently, uniparental inheritance was shown to promote adaptive evolution in mtDNA, potentially providing a third hypothesis for its evolution. Here, we explore this hypothesis theoretically and ask if the accumulation of beneficial mutations provides a sufficient fitness advantage for uniparental inheritance to invade a population in which mtDNA is inherited biparentally. In a deterministic model, uniparental inheritance increases in frequency but cannot replace biparental inheritance if only a single beneficial mtDNA mutation sweeps through the population. When we allow successive selective sweeps of mtDNA, however, uniparental inheritance can replace biparental inheritance. Using a stochastic model, we show that a combination of selection and drift facilitates the fixation of uniparental inheritance (compared to a neutral trait) when there is only a single selective mtDNA sweep. When we consider multiple mtDNA sweeps in a stochastic model, uniparental inheritance becomes even more likely to replace biparental inheritance. Our findings thus suggest that selective sweeps of beneficial mtDNA haplotypes can drive the evolution of uniparental inheritance. © 2017 The Author(s). Evolution © 2017 The Society for the Study of Evolution.

  2. Threshold received sound pressure levels of single 1-2 kHz and 6-7 kHz up-sweeps and down-sweeps causing startle responses in a harbor porpoise (Phocoena phocoena)

    NARCIS (Netherlands)

    Kastelein, R.A.; Steen, N.; Gransier, R.; Wensveen, P.J.; Jong, C.A.F. de

    2012-01-01

    Mid-frequency and low-frequency sonar systems produce frequency-modulated sweeps which may affect harbor porpoises. To study the effect of sweeps on behavioral responses (specifically startle responses, which we define as sudden changes in swimming speed and/or direction), a harbor porpoise in a

  3. Grain boundary sweeping and dissolution effects on fission product behaviour under severe fuel damage accident conditions

    International Nuclear Information System (INIS)

    Rest, J.

    1986-01-01

    The theoretical FASTGRASS-VFP model has been used in the interpretation of fission gas, iodine, tellurium, and cesium release from severe-fuel-damage (SFD) tests performed in the PBF reactor in Idaho. A theory of grain boundary sweeping of gas bubbles, gas bubble behavior during fuel liquefaction (destruction of grain boundaries due to formation of a U-rich melt phase), and during U-Zr eutectic melting has been included within the FASTGRASS-VFP formalism. The grain-boundary-sweeping theory considers the interaction between the moving grain boundary and two distinct size classes of bubbles, those on grain faces and on grain edges. The theory of the effects of fuel liquefaction and U-Zr eutectic melting on fission product behaviour considers the migration and coalescence of fission gas bubbles in either molten uranium, or a Zircaloy-Uranium eutectic melt. Results of the analyses demonstrate that intragranular fission product behavior during the tests can be interpreted in terms of a grain-growth/grain-boundary-sweeping mechanism that enhances the flow of fission products from within the grains to the grain boundaries. Whereas fuel liquefaction leads to an enhanced release of fission products in trace-irradiated fuel, the occurrence of fuel liquefaction in normally-irradiated fuel can degrade fission product release. This phenomenon is due in part to reduced gas-bubble mobilities in a viscous medium as compared to vapor transport, and in part to a degradation of grain growth rates and the subsequent decrease in grain-boundary sweeping of intragranular fission products into the liquified lamina. The analysis shows that total UO 2 dissolution due to eutectic melting leads to increased release for both trace-irradiated and normally-irradiated fuel. The FASTGRASS-VFP predictions, measured release rates from the above tests, and previously published release rates are compared and differences between fission product behavior in trace-irradiated and in normally

  4. Application of the WEPS and SWEEP models to non-agricultural disturbed lands

    Directory of Open Access Journals (Sweden)

    J. Tatarko

    2016-12-01

    Full Text Available Wind erosion not only affects agricultural productivity but also soil, air, and water quality. Dust and specifically particulate matter ≤10 μm (PM-10 has adverse effects on respiratory health and also reduces visibility along roadways, resulting in auto accidents. The Wind Erosion Prediction System (WEPS was developed by the USDA-Agricultural Research Service to simulate wind erosion and provide for conservation planning on cultivated agricultural lands. A companion product, known as the Single-Event Wind Erosion Evaluation Program (SWEEP, has also been developed which consists of the stand-alone WEPS erosion submodel combined with a graphical interface to simulate soil loss from single (i.e., daily wind storm events. In addition to agricultural lands, wind driven dust emissions also occur from other anthropogenic sources such as construction sites, mined and reclaimed areas, landfills, and other disturbed lands. Although developed for agricultural fields, WEPS and SWEEP are useful tools for simulating erosion by wind for non-agricultural lands where typical agricultural practices are not employed. On disturbed lands, WEPS can be applied for simulating long-term (i.e., multi-year erosion control strategies. SWEEP on the other hand was developed specifically for disturbed lands and can simulate potential soil loss for site- and date-specific planned surface conditions and control practices. This paper presents novel applications of WEPS and SWEEP for developing erosion control strategies on non-agricultural disturbed lands. Erosion control planning with WEPS and SWEEP using water and other dust suppressants, wind barriers, straw mulch, re-vegetation, and other management practices is demonstrated herein through the use of comparative simulation scenarios. The scenarios confirm the efficacy of the WEPS and SWEEP models as valuable tools for supporting the design of erosion control plans for disturbed lands that are not only cost-effective but

  5. Application of the WEPS and SWEEP models to non-agricultural disturbed lands.

    Science.gov (United States)

    Tatarko, J; van Donk, S J; Ascough, J C; Walker, D G

    2016-12-01

    Wind erosion not only affects agricultural productivity but also soil, air, and water quality. Dust and specifically particulate matter ≤10 μm (PM-10) has adverse effects on respiratory health and also reduces visibility along roadways, resulting in auto accidents. The Wind Erosion Prediction System (WEPS) was developed by the USDA-Agricultural Research Service to simulate wind erosion and provide for conservation planning on cultivated agricultural lands. A companion product, known as the Single-Event Wind Erosion Evaluation Program (SWEEP), has also been developed which consists of the stand-alone WEPS erosion submodel combined with a graphical interface to simulate soil loss from single (i.e., daily) wind storm events. In addition to agricultural lands, wind driven dust emissions also occur from other anthropogenic sources such as construction sites, mined and reclaimed areas, landfills, and other disturbed lands. Although developed for agricultural fields, WEPS and SWEEP are useful tools for simulating erosion by wind for non-agricultural lands where typical agricultural practices are not employed. On disturbed lands, WEPS can be applied for simulating long-term (i.e., multi-year) erosion control strategies. SWEEP on the other hand was developed specifically for disturbed lands and can simulate potential soil loss for site- and date-specific planned surface conditions and control practices. This paper presents novel applications of WEPS and SWEEP for developing erosion control strategies on non-agricultural disturbed lands. Erosion control planning with WEPS and SWEEP using water and other dust suppressants, wind barriers, straw mulch, re-vegetation, and other management practices is demonstrated herein through the use of comparative simulation scenarios. The scenarios confirm the efficacy of the WEPS and SWEEP models as valuable tools for supporting the design of erosion control plans for disturbed lands that are not only cost-effective but also incorporate

  6. Investigation of the Hydrodynamics of Sweep Blade in Hi-Speed Axial Fuel Pump Impeller

    Directory of Open Access Journals (Sweden)

    Ran Tao

    2013-01-01

    Full Text Available Fuel pump is a crucial component in aircraft engine ignition system. For the hi-speed axial fuel pumps, rotating stall triggers vortex and affects the operation stability and security. Sweep blade is widely used to solve the stability problems in aerodynamics field. Investigation on the hydrodynamics was conducted in this study. Based on the typical straight blade pump, positive and negative sweep blade pumps were modeled. With the large eddy simulation method, CFD simulations were conducted to calculate and analyze the flow characteristics in the pump models. To verify the simulation, experiments were also launched on the hydraulic test rig. Results show that the vortex occurs at the suction surface of blade and gathers near the blade tip region. Positive sweep blade is effective to reduce the hydraulic losses by driving the stalled fluid into the mid-part of blade. By applying the positive sweep blade on the axial fuel pump, the instability operating region will be diminished. Adopting sweep blade provides an effective means for stability and security of axial fuel pumps.

  7. Reduction of non-point source contaminants associated with road-deposited sediments by sweeping.

    Science.gov (United States)

    Kim, Do-Gun; Kang, Hee-Man; Ko, Seok-Oh

    2017-09-19

    Road-deposited sediments (RDS) on an expressway, residual RDS collected after sweeping, and RDS removed by means of sweeping were analyzed to evaluate the degree to which sweeping removed various non-point source contaminants. The total RDS load was 393.1 ± 80.3 kg/km and the RDS, residual RDS, and swept RDS were all highly polluted with organics, nutrients, and metals. Among the metals studied, Cu, Zn, Pb, Ni, Ca, and Fe were significantly enriched, and most of the contaminants were associated with particles within the size range from 63 μm to 2 mm. Sweeping reduced RDS and its associated contaminants by 33.3-49.1% on average. We also measured the biological oxygen demand (BOD) of RDS in the present work, representing to our knowledge the first time that this has been done; we found that RDS contains a significant amount of biodegradable organics and that the reduction of BOD by sweeping was higher than that of other contaminants. Significant correlations were found between the contaminants measured, indicating that the organics and the metals originated from both exhaust and non-exhaust particles. Meanwhile, the concentrations of Cu and Ni were higher in 63 μm-2 mm particles than in smaller particles, suggesting that some metals in RDS likely exist intrinsically in particles, rather than only as adsorbates on particle surfaces. Overall, the results in this study showed that sweeping to collect RDS can be a good alternative for reduction of contaminants in runoff.

  8. A particle method with adjustable transport properties - the generalized consistent Boltzmann algorithm

    International Nuclear Information System (INIS)

    Garcia, A.L.; Alexander, F.J.; Alder, B.J.

    1997-01-01

    The consistent Boltzmann algorithm (CBA) for dense, hard-sphere gases is generalized to obtain the van der Waals equation of state and the corresponding exact viscosity at all densities except at the highest temperatures. A general scheme for adjusting any transport coefficients to higher values is presented

  9. Concatenating algorithms for parallel numerical simulations coupling radiation hydrodynamics with neutron transport

    International Nuclear Information System (INIS)

    Mo Zeyao

    2004-11-01

    Multiphysics parallel numerical simulations are usually essential to simplify researches on complex physical phenomena in which several physics are tightly coupled. It is very important on how to concatenate those coupled physics for fully scalable parallel simulation. Meanwhile, three objectives should be balanced, the first is efficient data transfer among simulations, the second and the third are efficient parallel executions and simultaneously developments of those simulation codes. Two concatenating algorithms for multiphysics parallel numerical simulations coupling radiation hydrodynamics with neutron transport on unstructured grid are presented. The first algorithm, Fully Loosely Concatenation (FLC), focuses on the independence of code development and the independence running with optimal performance of code. The second algorithm. Two Level Tightly Concatenation (TLTC), focuses on the optimal tradeoffs among above three objectives. Theoretical analyses for communicational complexity and parallel numerical experiments on hundreds of processors on two parallel machines have showed that these two algorithms are efficient and can be generalized to other multiphysics parallel numerical simulations. In especial, algorithm TLTC is linearly scalable and has achieved the optimal parallel performance. (authors)

  10. Matrix product operators, matrix product states, and ab initio density matrix renormalization group algorithms

    Science.gov (United States)

    Chan, Garnet Kin-Lic; Keselman, Anna; Nakatani, Naoki; Li, Zhendong; White, Steven R.

    2016-07-01

    Current descriptions of the ab initio density matrix renormalization group (DMRG) algorithm use two superficially different languages: an older language of the renormalization group and renormalized operators, and a more recent language of matrix product states and matrix product operators. The same algorithm can appear dramatically different when written in the two different vocabularies. In this work, we carefully describe the translation between the two languages in several contexts. First, we describe how to efficiently implement the ab initio DMRG sweep using a matrix product operator based code, and the equivalence to the original renormalized operator implementation. Next we describe how to implement the general matrix product operator/matrix product state algebra within a pure renormalized operator-based DMRG code. Finally, we discuss two improvements of the ab initio DMRG sweep algorithm motivated by matrix product operator language: Hamiltonian compression, and a sum over operators representation that allows for perfect computational parallelism. The connections and correspondences described here serve to link the future developments with the past and are important in the efficient implementation of continuing advances in ab initio DMRG and related algorithms.

  11. Nonadiabatic exchange dynamics during adiabatic frequency sweeps.

    Science.gov (United States)

    Barbara, Thomas M

    2016-04-01

    A Bloch equation analysis that includes relaxation and exchange effects during an adiabatic frequency swept pulse is presented. For a large class of sweeps, relaxation can be incorporated using simple first order perturbation theory. For anisochronous exchange, new expressions are derived for exchange augmented rotating frame relaxation. For isochronous exchange between sites with distinct relaxation rate constants outside the extreme narrowing limit, simple criteria for adiabatic exchange are derived and demonstrate that frequency sweeps commonly in use may not be adiabatic with regard to exchange unless the exchange rates are much larger than the relaxation rates. Otherwise, accurate assessment of the sensitivity to exchange dynamics will require numerical integration of the rate equations. Examples of this situation are given for experimentally relevant parameters believed to hold for in-vivo tissue. These results are of significance in the study of exchange induced contrast in magnetic resonance imaging. Copyright © 2016 Elsevier Inc. All rights reserved.

  12. A sweep plate emittance scanner for high-power CW ion beams

    International Nuclear Information System (INIS)

    Debiak, T.W.; Ng, Y.; Sredniawski, J.; Stasi, W.

    1996-01-01

    Sweep plate scanners are preferred for emittance measurement due to their versatility, simplicity, and precision. At the Advanced Technology and Development Center of Northrop Grumman, we have routinely used these devices for characterization of injector beams with less than 20 W/cm 2 average power density. To characterize higher power beams, like those required for production of tritium or for radioactive waste transmutation, the scanner pod and data collection algorithm must be redesigned due to the possibility of melting the scanner's protective front face or distorting the precision entrance knife edges. Among the methods we have used to mitigate these effects, one consists of drastically reducing the amount of time required for data collection. In this method, the emittance scanner pod traverses the beam in two passes, each requiring less than 0.5 second. In the first pass, the phase space limits of the beam are determined. In the second pass, data is collected primarily within the phase space region limits determined in the first pass. In this way, enough points are collected to assure that the precision of the measurement is high, even though the data collection time for each scan is less than 0.5 second. This paper will describe the layout of the scanner components, the data collection electronics and algorithm, and the data analysis. (author)

  13. From analytical solutions of solute transport equations to multidimensional time-domain random walk (TDRW) algorithms

    Science.gov (United States)

    Bodin, Jacques

    2015-03-01

    In this study, new multi-dimensional time-domain random walk (TDRW) algorithms are derived from approximate one-dimensional (1-D), two-dimensional (2-D), and three-dimensional (3-D) analytical solutions of the advection-dispersion equation and from exact 1-D, 2-D, and 3-D analytical solutions of the pure-diffusion equation. These algorithms enable the calculation of both the time required for a particle to travel a specified distance in a homogeneous medium and the mass recovery at the observation point, which may be incomplete due to 2-D or 3-D transverse dispersion or diffusion. The method is extended to heterogeneous media, represented as a piecewise collection of homogeneous media. The particle motion is then decomposed along a series of intermediate checkpoints located on the medium interface boundaries. The accuracy of the multi-dimensional TDRW method is verified against (i) exact analytical solutions of solute transport in homogeneous media and (ii) finite-difference simulations in a synthetic 2-D heterogeneous medium of simple geometry. The results demonstrate that the method is ideally suited to purely diffusive transport and to advection-dispersion transport problems dominated by advection. Conversely, the method is not recommended for highly dispersive transport problems because the accuracy of the advection-dispersion TDRW algorithms degrades rapidly for a low Péclet number, consistent with the accuracy limit of the approximate analytical solutions. The proposed approach provides a unified methodology for deriving multi-dimensional time-domain particle equations and may be applicable to other mathematical transport models, provided that appropriate analytical solutions are available.

  14. Parallel algorithms for 2-D cylindrical transport equations of Eigenvalue problem

    International Nuclear Information System (INIS)

    Wei, J.; Yang, S.

    2013-01-01

    In this paper, aimed at the neutron transport equations of eigenvalue problem under 2-D cylindrical geometry on unstructured grid, the discrete scheme of Sn discrete ordinate and discontinuous finite is built, and the parallel computation for the scheme is realized on MPI systems. Numerical experiments indicate that the designed parallel algorithm can reach perfect speedup, it has good practicality and scalability. (authors)

  15. Using Computational Fluid Dynamics and Experiments to Design Sweeping Jets for High Reynolds Number Cruise Configurations

    Science.gov (United States)

    Jones, Gregory S.; Milholen, William E., II; Fell, Jared S.; Webb, Sandy R.; Cagle, C. Mark

    2016-01-01

    The application of a sweeping jet actuator to a circulation control system was initiated by a risk reduction series of experiments to optimize the authority of a single sweeping jet actuator. The sweeping jet design was integrated into the existing Fundamental Aerodynamic Subsonic Transonic- Modular Active Control (FAST-MAC) model by replacing the steady blowing system with an array of thirty-nine sweeping jet cartridges. A constant slot height to wing chord ratio was similar to the steady blowing configuration resulting in each actuator having a unique in size for the sweeping jet configuration. While this paper will describe the scaling and optimization of the actuators for future high Reynolds number applications, the major focus of this effort was to target the transonic flight regime by increasing the amplitude authority of the actuator. This was accomplished by modifying the diffuser of the sweeping jet actuator, and this paper highlights twelve different diffuser designs. The experimental portion of this work was completed in the NASA Langley National Transonic Facility.

  16. The frequency and level of sweep in mixed hardwood saw logs in the eastern United States

    Science.gov (United States)

    Peter Hamner; Marshall S. White; Philip A. Araman

    2007-01-01

    Hardwood sawmills traditionally saw logs in a manner that either orients sawlines parallel to the log central axis (straight sawing) or the log surface (allowing for taper). Sweep is characterized as uniform curvature along the entire length of a log. For logs with sweep, lumber yield losses from straight and taper sawing increase with increasing levels of sweep. Curve...

  17. Measurements of the eigenfunction of reversed shear Alfvén eigenmodes that sweep downward in frequency

    International Nuclear Information System (INIS)

    Heidbrink, W. W.; Austin, M. E.; Spong, D. A.; Tobias, B. J.; Van Zeeland, M. A.

    2013-01-01

    Reversed shear Alfvén eigenmodes (RSAEs) usually sweep upward in frequency when the minimum value of the safety factor q min decreases in time. On rare occasions, RSAEs sweep downward prior to the upward sweep. Electron cyclotron emission measurements show that the radial eigenfunction during the downsweeping phase is similar to the eigenfunction of normal, upsweeping RSAEs

  18. On detecting incomplete soft or hard selective sweeps using haplotype structure

    DEFF Research Database (Denmark)

    Ferrer-Admetlla, Anna; Liang, Mason; Korneliussen, Thorfinn Sand

    2014-01-01

    We present a new haplotype-based statistic (nSL) for detecting both soft and hard sweeps in population genomic data from a single population. We compare our new method with classic single-population haplotype and site frequency spectrum (SFS)-based methods and show that it is more robust, particu......We present a new haplotype-based statistic (nSL) for detecting both soft and hard sweeps in population genomic data from a single population. We compare our new method with classic single-population haplotype and site frequency spectrum (SFS)-based methods and show that it is more robust......, particularly to recombination rate variation. However, all statistics show some sensitivity to the assumptions of the demographic model. Additionally, we show that nSL has at least as much power as other methods under a number of different selection scenarios, most notably in the cases of sweeps from standing...

  19. Numerical simulation of incidence and sweep effects on delta wing vortex breakdown

    Science.gov (United States)

    Ekaterinaris, J. A.; Schiff, Lewis B.

    1994-01-01

    The structure of the vortical flowfield over delta wings at high angles of attack was investigated. Three-dimensional Navier-Stokes numerical simulations were carried out to predict the complex leeward-side flowfield characteristics, including leading-edge separation, secondary separation, and vortex breakdown. Flows over a 75- and a 63-deg sweep delta wing with sharp leading edges were investigated and compared with available experimental data. The effect of variation of circumferential grid resolution grid resolution in the vicinity of the wing leading edge on the accuracy of the solutions was addressed. Furthermore, the effect of turbulence modeling on the solutions was investigated. The effects of variation of angle of attack on the computed vortical flow structure for the 75-deg sweep delta wing were examined. At moderate angles of attack no vortex breakdown was observed. When a critical angle of attack was reached, bubble-type vortex breakdown was found. With further increase in angle of attack, a change from bubble-type breakdown to spiral-type vortex breakdown was predicted by the numerical solution. The effects of variation of sweep angle and freestream Mach number were addressed with the solutions on a 63-deg sweep delta wing.

  20. Load consequences when sweeping blades - A case study of a 5 MW pitch controlled wind turbine

    Energy Technology Data Exchange (ETDEWEB)

    Verelst, D.R.S.; Larsen, Torben J.

    2010-08-15

    The generic 5 MW NREL wind turbine model is used in Risoe's aeroelastic simulator HAWC2 to investigate 120 different swept blade configurations (forward and backward sweep). Sensitivity for 2 different controllers is considered as well. Backward sweep results in a pitch to feather torsional moment of the blade, effectively reducing blade twist angles under increased loading. This behaviour results in decreased flap-wise fatigue and extreme loads, an increase for edge-wise fatigue loading and status quo or slight decrease in extreme loads (depending on the controller). Tower base and shaft-end bending moments are reduced as well. Forward sweep leads to an increase in angle of attack under loading. For a pitch controlled turbine this leads to an increase in fatigue and extreme loading in all cases. A controller inflicted instability is present for the more extreme forward swept cases. Due to the shape of considered sweep curves, an inherent and significant increase in torsional blade root bending moment is noted. A boomerang shaped sweep curve is proposed to counteract this problematic increased loading. Controller sensitivity shows that adding sweep affects some loadings differently. Power output is reduced for backward sweep since the blade twist is optimized as a rigid structure, ignoring the torsional deformations which for a swept blade can be significant. (author)

  1. Effect of blade sweep on inlet flow in axial compressor cascades

    Directory of Open Access Journals (Sweden)

    Hao Chang

    2015-02-01

    Full Text Available This paper presents comparative numerical studies to investigate the effects of blade sweep on inlet flow in axial compressor cascades. A series of swept and straight cascades was modeled in order to obtain a general understanding of the inlet flow field that is induced by sweep. A computational fluid dynamics (CFD package was used to simulate the cascades and obtain the required three-dimensional (3D flow parameters. A circumferentially averaged method was introduced which provided the circumferential fluctuation (CF terms in the momentum equation. A program for data reduction was conducted to obtain a circumferentially averaged flow field. The influences of the inlet flow fields of the cascades were studied and spanwise distributions of each term in the momentum equation were analyzed. The results indicate that blade sweep does affect inlet radial equilibrium. The characteristic of radial fluid transfer is changed and thus influencing the axial velocity distributions. The inlet flow field varies mainly due to the combined effect of the radial pressure gradient and the CF component. The axial velocity varies consistently with the incidence variation induced by the sweep, as observed in the previous literature. In addition, factors that might influence the radial equilibrium such as blade camber angles, solidity and the effect of the distance from the leading edge are also taken into consideration and comparatively analyzed.

  2. Sweep-twist adaptive rotor blade : final project report.

    Energy Technology Data Exchange (ETDEWEB)

    Ashwill, Thomas D.

    2010-02-01

    Knight & Carver was contracted by Sandia National Laboratories to develop a Sweep Twist Adaptive Rotor (STAR) blade that reduced operating loads, thereby allowing a larger, more productive rotor. The blade design used outer blade sweep to create twist coupling without angled fiber. Knight & Carver successfully designed, fabricated, tested and evaluated STAR prototype blades. Through laboratory and field tests, Knight & Carver showed the STAR blade met the engineering design criteria and economic goals for the program. A STAR prototype was successfully tested in Tehachapi during 2008 and a large data set was collected to support engineering and commercial development of the technology. This report documents the methodology used to develop the STAR blade design and reviews the approach used for laboratory and field testing. The effort demonstrated that STAR technology can provide significantly greater energy capture without higher operating loads on the turbine.

  3. The design of the public transport lines with the use of the fast genetic algorithm

    Directory of Open Access Journals (Sweden)

    Aleksander Król

    2015-09-01

    Full Text Available Background: The growing role of public transport and the pressure of economic criteria requires the new optimization tools for process of public transport planning. These problems are computationally very complex, thus it is preferable to use various approximate methods, leading to a good solution within an acceptable time. Methods: One of such method is the genetic algorithm mimicking the processes of evolution and natural selection in the nature. In this paper, the different variants of the public transport lines layout are subjected to the artificial selection. The essence of the proposed approach is a simplified method of calculating the value of the fit function for a single individual, which brings relatively short computation time even for large jobs. Results: It was shown that despite the introduced simplifications the quality of the results is not worsened. Using the data obtained from KZK GOP (Communications Municipal Association of Upper Silesian Industrial Region the described algorithm was used to optimize the layout of the network of bus lines located within the borders of Katowice. Conclusion: The proposed algorithm was applied to a real, very complex network of public transportation and a possibility of a significant improvement of its efficiency was indicated. The obtained results give hope that the presented model, after some improvements can be the basis of the scientific method, and in a consequence of a further development to find practical application.

  4. Sweep excitation with order tracking: A new tactic for beam crack analysis

    Science.gov (United States)

    Wei, Dongdong; Wang, KeSheng; Zhang, Mian; Zuo, Ming J.

    2018-04-01

    Crack detection in beams and beam-like structures is an important issue in industry and has attracted numerous investigations. A local crack leads to global system dynamics changes and produce non-linear vibration responses. Many researchers have studied these non-linearities for beam crack diagnosis. However, most reported methods are based on impact excitation and constant frequency excitation. Few studies have focused on crack detection through external sweep excitation which unleashes abundant dynamic characteristics of the system. Together with a signal resampling technique inspired by Computed Order Tracking, this paper utilize vibration responses under sweep excitations to diagnose crack status of beams. A data driven method for crack depth evaluation is proposed and window based harmonics extracting approaches are studied. The effectiveness of sweep excitation and the proposed method is experimentally validated.

  5. Routing and scheduling of hazardous materials shipments: algorithmic approaches to managing spent nuclear fuel transport

    International Nuclear Information System (INIS)

    Cox, R.G.

    1984-01-01

    Much controversy surrounds government regulation of routing and scheduling of Hazardous Materials Transportation (HMT). Increases in operating costs must be balanced against expected benefits from local HMT bans and curfews when promulgating or preempting HMT regulations. Algorithmic approaches for evaluating HMT routing and scheduling regulatory policy are described. A review of current US HMT regulatory policy is presented to provide a context for the analysis. Next, a multiobjective shortest path algorithm to find the set of efficient routes under conflicting objectives is presented. This algorithm generates all efficient routes under any partial ordering in a single pass through the network. Also, scheduling algorithms are presented to estimate the travel time delay due to HMT curfews along a route. Algorithms are presented assuming either deterministic or stochastic travel times between curfew cities and also possible rerouting to avoid such cities. These algorithms are applied to the case study of US highway transport of spent nuclear fuel from reactors to permanent repositories. Two data sets were used. One data set included the US Interstate Highway System (IHS) network with reactor locations, possible repository sites, and 150 heavily populated areas (HPAs). The other data set contained estimates of the population residing with 0.5 miles of the IHS and the Eastern US. Curfew delay is dramatically reduced by optimally scheduling departure times unless inter-HPA travel times are highly uncertain. Rerouting shipments to avoid HPAs is a less efficient approach to reducing delay

  6. Michelson mode selector for spectral range stabilization in a self-sweeping fiber laser.

    Science.gov (United States)

    Tkachenko, A Yu; Vladimirskaya, A D; Lobach, I A; Kablukov, S I

    2018-04-01

    We report on spectral range stabilization in a self-sweeping laser by adding a narrowband fiber Bragg grating (FBG) to the output mirror in the Michelson configuration. The effects of FBG reflectivity and optical path difference in the Michelson interferometer on the laser spectral dynamics are investigated. Optimization of the interferometer allows us to demonstrate broadband (over 16 nm) self-sweeping operation and reduction of the start and stop wavelength fluctuations by two orders and one order of magnitude (∼100 and 15 times) for start and stop bounds, respectively (down to several picometers). The proposed approaches significantly improve quality of the spectral dynamics and facilitate application of the self-sweeping lasers.

  7. Solar Wind Earth Exchange Project (SWEEP)

    Science.gov (United States)

    2016-10-28

    highly charged ions of the solar wind. The main challenge in predicting the resultant photon flux in the X-ray energy bands is due to the...Newton, an X-ray astronomical observatory. We use OMNI solar wind conditions, heavy ion composition data from ACE, the Hodges neutral hydrogen model...of SWEEP was to compare theoretical models of X-ray emission in the terrestrial magnetosphere caused by the Solar Wind Charge Exchange

  8. Magnetovoltage Measurements and Field Sweep Rate Dependence of V-H curves in Superconducting Polycrystalline Y1Ba2Cu3O7-x

    International Nuclear Information System (INIS)

    Yetis, H; Altinkok, A; Olutas, M; Kilic, A; Kilic, K; Cetin, O

    2006-01-01

    Magnetovoltage measurements (V-H curves) were carried out in superconducting polycrystalline bulk Y 1 Ba 2 Cu 3 O 7-x (YBCO) material as a function of current (I), temperature (T), field sweep rate (dH/dt) and field orientation with respect to the transport current. A relative decrease in the dissipation measured in V-H curves was observed as dH/dt is increased, which implies that the time spent to plot the whole cycle has an importance on the evolution of the V-H curves. Thus, it could be possible to observe the relaxation effects in magnetovoltage measurements. In addition, the several significant steps and plateaus in V-H curves evolve depending on the magnitude of the transport current and also dH/dt. These observations were attributed to locking of the flux lines to decrease or increase in size of the easy motion flow channels. The strong hysteresis effects in V-H curves were discussed mainly by means of the flux trapping within the granularity of sample and the different degree of the inhomogeneous flux motion with respect to the sweeping of the external magnetic field up and down

  9. Enhancement of the conductivity detection signal in capillary electrophoresis systems using neutral cyclodextrins as sweeping agents.

    Science.gov (United States)

    Boublík, Milan; Riesová, Martina; Dubský, Pavel; Gaš, Bohuslav

    2018-06-01

    Conductivity detection is a universal detection technique often encountered in electrophoretic separation systems, especially in modern chip-electrophoresis based devices. On the other hand, it is sparsely combined with another contemporary trend of enhancing limits of detection by means of various preconcentration strategies. This can be attributed to the fact that a preconcentration experimental setup usually brings about disturbances in a conductivity baseline. Sweeping with a neutral sweeping agent seems a good candidate for overcoming this problem. A neutral sweeping agent does not hinder the conductivity detection while a charged analyte may preconcentrate on its boundary due to a decrease in its effective mobility. This study investigates such sweeping systems theoretically, by means of computer simulations, and experimentally. A formula is provided for the reliable estimation of the preconcentration factor. Additionally, it is demonstrated that the conductivity signal can significantly benefit from slowing down the analyte and thus the overall signal enhancement can easily overweight amplification caused solely by the sweeping process. The overall enhancement factor can be deduced a priori from the linearized theory of electrophoresis implemented in the PeakMaster freeware. Sweeping by neutral cyclodextrin is demonstrated on an amplification of a conductivity signal of flurbiprofen in a real drug sample. Finally, a possible formation of unexpected system peaks in systems with a neutral sweeping agent is revealed by the computer simulation and confirmed experimentally. © 2018 WILEY-VCH Verlag GmbH & Co. KGaA, Weinheim.

  10. An angularly refineable phase space finite element method with approximate sweeping procedure

    International Nuclear Information System (INIS)

    Kophazi, J.; Lathouwers, D.

    2013-01-01

    An angularly refineable phase space finite element method is proposed to solve the neutron transport equation. The method combines the advantages of two recently published schemes. The angular domain is discretized into small patches and patch-wise discontinuous angular basis functions are restricted to these patches, i.e. there is no overlap between basis functions corresponding to different patches. This approach yields block diagonal Jacobians with small block size and retains the possibility for S n -like approximate sweeping of the spatially discontinuous elements in order to provide efficient preconditioners for the solution procedure. On the other hand, the preservation of the full FEM framework (as opposed to collocation into a high-order S n scheme) retains the possibility of the Galerkin interpolated connection between phase space elements at arbitrary levels of discretization. Since the basis vectors are not orthonormal, a generalization of the Riemann procedure is introduced to separate the incoming and outgoing contributions in case of unstructured meshes. However, due to the properties of the angular discretization, the Riemann procedure can be avoided at a large fraction of the faces and this fraction rapidly increases as the level of refinement increases, contributing to the computational efficiency. In this paper the properties of the discretization scheme are studied with uniform refinement using an iterative solver based on the S 2 sweep order of the spatial elements. The fourth order convergence of the scalar flux is shown as anticipated from earlier schemes and the rapidly decreasing fraction of required Riemann faces is illustrated. (authors)

  11. Implementation vigenere algorithm using microcontroller for sending SMS in monitoring radioactive substances transport system

    International Nuclear Information System (INIS)

    Adi Abimanyu; Nurhidayat; Jumari

    2013-01-01

    Aspects of safety and security of radioactive substances from the sender to the receiver is to be secured for not to harm humans. In general, monitoring the transport of radioactive materials is done by communication with a telephone conversation to determine the location and rate of exposure radioactive substances. From the aspect of safety, communication through telephone conversations easily interpreted by others, in addition the possibility of human-error is quite high. SMS service is known for its ease in terms of use so that SMS can be used as a substitute for communication through telephone conversations to monitor the rate of radiation exposure and the position of radioactive substances in the transport of radioactive substances. The system monitors the transport of radioactive materials developed by implement vigenere algorithms using a microcontroller for sending SMS (Short Message Service) to communicate. Tests was conducted to testing encryption and description and computation time required. From the test results obtained they have been successfully implemented vigenere algorithm to encrypt and decrypt the messages on the transport of radioactive monitoring system and the computational time required to encrypt and decrypt the data is 13.05 ms for 36 characters and 13.61 for 37 characters. So for every single character require computing time 0.56 ms. (author)

  12. S/HIC: Robust Identification of Soft and Hard Sweeps Using Machine Learning.

    Directory of Open Access Journals (Sweden)

    Daniel R Schrider

    2016-03-01

    Full Text Available Detecting the targets of adaptive natural selection from whole genome sequencing data is a central problem for population genetics. However, to date most methods have shown sub-optimal performance under realistic demographic scenarios. Moreover, over the past decade there has been a renewed interest in determining the importance of selection from standing variation in adaptation of natural populations, yet very few methods for inferring this model of adaptation at the genome scale have been introduced. Here we introduce a new method, S/HIC, which uses supervised machine learning to precisely infer the location of both hard and soft selective sweeps. We show that S/HIC has unrivaled accuracy for detecting sweeps under demographic histories that are relevant to human populations, and distinguishing sweeps from linked as well as neutrally evolving regions. Moreover, we show that S/HIC is uniquely robust among its competitors to model misspecification. Thus, even if the true demographic model of a population differs catastrophically from that specified by the user, S/HIC still retains impressive discriminatory power. Finally, we apply S/HIC to the case of resequencing data from human chromosome 18 in a European population sample, and demonstrate that we can reliably recover selective sweeps that have been identified earlier using less specific and sensitive methods.

  13. Transport synthetic acceleration with opposing reflecting boundary conditions

    Energy Technology Data Exchange (ETDEWEB)

    Zika, M R; Adams, M L

    2000-02-01

    The transport synthetic acceleration (TSA) scheme is extended to problems with opposing reflecting boundary conditions. This synthetic method employs a simplified transport operator as its low-order approximation. A procedure is developed that allows the use of the conjugate gradient (CG) method to solve the resulting low-order system of equations. Several well-known transport iteration algorithms are cast in a linear algebraic form to show their equivalence to standard iterative techniques. Source iteration in the presence of opposing reflecting boundary conditions is shown to be equivalent to a (poorly) preconditioned stationary Richardson iteration, with the preconditioner defined by the method of iterating on the incident fluxes on the reflecting boundaries. The TSA method (and any synthetic method) amounts to a further preconditioning of the Richardson iteration. The presence of opposing reflecting boundary conditions requires special consideration when developing a procedure to realize the CG method for the proposed system of equations. The CG iteration may be applied only to symmetric positive definite matrices; this condition requires the algebraic elimination of the boundary angular corrections from the low-order equations. As a consequence of this elimination, evaluating the action of the resulting matrix on an arbitrary vector involves two transport sweeps and a transmission iteration. Results of applying the acceleration scheme to a simple test problem are presented.

  14. 3D flow visualizations by means of laser beam sweeps

    International Nuclear Information System (INIS)

    Prenel, J.P.; Porcar, R.; Diemunsch, G.

    1987-01-01

    A method in which two-dimensional aperiodic or periodic sweeps are used to produce three-dimensional light sweeps makes possible the quasi-simultaneous recording of different specific planes of a flow, or the characterization of a fluid without revolution symmetry. The optical device consists of two scanners (whose axes are orthogonal) set into a telescope, allowing fine focusing of the light sheets in the study zone. The method also allows visualizations on skewed surfaces, particularly those of flows without a cylindrical geometry; it is applicable from low velocity, as in heat convection, to supersonic velocity, as in the analysis of a nonaxisymmetric ejector. 8 references

  15. Design of a fuzzy differential evolution algorithm to predict non-deposition sediment transport

    Science.gov (United States)

    Ebtehaj, Isa; Bonakdari, Hossein

    2017-12-01

    Since the flow entering a sewer contains solid matter, deposition at the bottom of the channel is inevitable. It is difficult to understand the complex, three-dimensional mechanism of sediment transport in sewer pipelines. Therefore, a method to estimate the limiting velocity is necessary for optimal designs. Due to the inability of gradient-based algorithms to train Adaptive Neuro-Fuzzy Inference Systems (ANFIS) for non-deposition sediment transport prediction, a new hybrid ANFIS method based on a differential evolutionary algorithm (ANFIS-DE) is developed. The training and testing performance of ANFIS-DE is evaluated using a wide range of dimensionless parameters gathered from the literature. The input combination used to estimate the densimetric Froude number ( Fr) parameters includes the volumetric sediment concentration ( C V ), ratio of median particle diameter to hydraulic radius ( d/R), ratio of median particle diameter to pipe diameter ( d/D) and overall friction factor of sediment ( λ s ). The testing results are compared with the ANFIS model and regression-based equation results. The ANFIS-DE technique predicted sediment transport at limit of deposition with lower root mean square error (RMSE = 0.323) and mean absolute percentage of error (MAPE = 0.065) and higher accuracy ( R 2 = 0.965) than the ANFIS model and regression-based equations.

  16. Ka-Band Digital Beamforming and SweepSAR Demonstration for Ice and Solid Earth Topography

    Science.gov (United States)

    Sadowy, Gregory; Ghaemi, Hirad; Heavy, Brandon; Perkovic, Dragana; Quddus, Momin; Zawadzki, Mark; Moller, Delwyn

    2010-01-01

    GLISTIN is an instrument concept for a single-pass interferometric SAR operating at 35.6 GHz. To achieve large swath widths using practical levels of transmitter power, a digitally-beamformed planar waveguide array is used. This paper describes results from a ground-based demonstration of a 16-receiver prototype. Furthermore, SweepSAR is emerging as promising technique for achieving very wide swaths for surface change detection. NASA and DLR are studying this approach for the DESDynI and Tandem-L missions. SweepSAR employs a reflector with a digitally-beamformed array feed. We will describe development of an airborne demonstration of SweepSAR using the GLISTIN receiver array and a reflector.

  17. Understanding Air Transportation Market Dynamics Using a Search Algorithm for Calibrating Travel Demand and Price

    Science.gov (United States)

    Kumar, Vivek; Horio, Brant M.; DeCicco, Anthony H.; Hasan, Shahab; Stouffer, Virginia L.; Smith, Jeremy C.; Guerreiro, Nelson M.

    2015-01-01

    This paper presents a search algorithm based framework to calibrate origin-destination (O-D) market specific airline ticket demands and prices for the Air Transportation System (ATS). This framework is used for calibrating an agent based model of the air ticket buy-sell process - Airline Evolutionary Simulation (Airline EVOS) -that has fidelity of detail that accounts for airline and consumer behaviors and the interdependencies they share between themselves and the NAS. More specificially, this algorithm simultaneous calibrates demand and airfares for each O-D market, to within specified threshold of a pre-specified target value. The proposed algorithm is illustrated with market data targets provided by the Transportation System Analysis Model (TSAM) and Airline Origin and Destination Survey (DB1B). Although we specify these models and datasources for this calibration exercise, the methods described in this paper are applicable to calibrating any low-level model of the ATS to some other demand forecast model-based data. We argue that using a calibration algorithm such as the one we present here to synchronize ATS models with specialized forecast demand models, is a powerful tool for establishing credible baseline conditions in experiments analyzing the effects of proposed policy changes to the ATS.

  18. Toward Cooling Uniformity: Investigation of Spiral, Sweeping Holes, and Unconventional Cooling Paradigms

    Science.gov (United States)

    Shyam, Vikram; Thurman, Douglas R.; Poinsatte, Philip E.; Ameri, Ali A.; Culley, Dennis E.

    2018-01-01

    Surface infrared thermography, hotwire anemometry, and thermocouple surveys were performed on two new film cooling hole geometries: spiral/rifled holes and fluidic sweeping holes. Ways to quantify the efficacy of novel cooling holes that are asymmetric, not uniformly spaced or that show variation from hole to hole are presented. The spiral holes attempt to induce large-scale vorticity to the film cooling jet as it exits the hole to prevent the formation of the kidney shaped vortices commonly associated with film cooling jets. The fluidic sweeping hole uses a passive in-hole geometry to induce jet sweeping at frequencies that scale with blowing ratios. The spiral hole performance is compared to that of round holes with and without compound angles. The fluidic hole is of the diffusion class of holes and is therefore compared to a 777 hole and square holes. A patent-pending spiral hole design showed the highest potential of the nondiffusion type hole configurations. Velocity contours and flow temperature were acquired at discreet cross-sections of the downstream flow field. The passive fluidic sweeping hole shows the most uniform cooling distribution but suffers from low span-averaged effectiveness levels due to enhanced mixing. The data was taken at a Reynolds number of 11,000 based on hole diameter and freestream velocity. Infrared thermography was taken for blowing ratios of 1.0, 1.5, 2.0, and 2.5 at a density ratio of 1.05. The flow inside the fluidic sweeping hole was studied using 3D unsteady RANS. A section on ideas for future work is included that addresses issues of quantifying cooling uniformity and provides some ideas for changing the way we think about cooling such as changing the direction of cooling or coupling acoustic devices to cooling holes to regulate frequency.

  19. Maximum power point tracking for PV systems under partial shading conditions using current sweeping

    International Nuclear Information System (INIS)

    Tsang, K.M.; Chan, W.L.

    2015-01-01

    Highlights: • A novel approach for tracking the maximum power point of photovoltaic systems. • Able to handle both the uniform insolation and partial shading conditions. • Maximum power point tracking based on current sweeping. - Abstract: Partial shading on photovoltaic (PV) arrays causes multiple peaks on the output power–voltage characteristic curve and local searching technique such as perturb and observe (P&O) method could easily fail in searching for the global maximum. Moreover, existing global searching techniques are still not very satisfactory in terms of speed and implementation complexity. In this paper, a fast global maximum power point (MPPT) tracking method which is using current sweeping for photovoltaic arrays under partial shading conditions is proposed. Unlike conventional approach, the proposed method is current based rather than voltage based. The initial maximum power point will be derived based on a current sweeping test and the maximum power point can be enhanced by a finer local search. The speed of the global search is mainly governed by the apparent time constant of the PV array and the generation of a fast current sweeping test. The fast current sweeping test can easily be realized by a DC/DC boost converter with a very fast current control loop. Experimental results are included to demonstrate the effectiveness of the proposed global searching scheme

  20. Using temperature sweeps to investigate rheology of bioplastics

    Science.gov (United States)

    As part of research toward production of protein-based bioplastics, small amplitude oscillatory shear analyses were performed in the temperature sweep mode to examine protein blends in the presence of wheat flour and glycerol. The elastic modulus (G') of these samples was much higher than the visco...

  1. Evaluation of Monte Carlo electron-Transport algorithms in the integrated Tiger series codes for stochastic-media simulations

    International Nuclear Information System (INIS)

    Franke, B.C.; Kensek, R.P.; Prinja, A.K.

    2013-01-01

    Stochastic-media simulations require numerous boundary crossings. We consider two Monte Carlo electron transport approaches and evaluate accuracy with numerous material boundaries. In the condensed-history method, approximations are made based on infinite-medium solutions for multiple scattering over some track length. Typically, further approximations are employed for material-boundary crossings where infinite-medium solutions become invalid. We have previously explored an alternative 'condensed transport' formulation, a Generalized Boltzmann-Fokker-Planck (GBFP) method, which requires no special boundary treatment but instead uses approximations to the electron-scattering cross sections. Some limited capabilities for analog transport and a GBFP method have been implemented in the Integrated Tiger Series (ITS) codes. Improvements have been made to the condensed history algorithm. The performance of the ITS condensed-history and condensed-transport algorithms are assessed for material-boundary crossings. These assessments are made both by introducing artificial material boundaries and by comparison to analog Monte Carlo simulations. (authors)

  2. Performance analysis of multidimensional wavefront algorithms with application to deterministic particle transport

    International Nuclear Information System (INIS)

    Hoisie, A.; Lubeck, O.; Wasserman, H.

    1998-01-01

    The authors develop a model for the parallel performance of algorithms that consist of concurrent, two-dimensional wavefronts implemented in a message passing environment. The model, based on a LogGP machine parameterization, combines the separate contributions of computation and communication wavefronts. They validate the model on three important supercomputer systems, on up to 500 processors. They use data from a deterministic particle transport application taken from the ASCI workload, although the model is general to any wavefront algorithm implemented on a 2-D processor domain. They also use the validated model to make estimates of performance and scalability of wavefront algorithms on 100-TFLOPS computer systems expected to be in existence within the next decade as part of the ASCI program and elsewhere. In this context, the authors analyze two problem sizes. Their model shows that on the largest such problem (1 billion cells), inter-processor communication performance is not the bottleneck. Single-node efficiency is the dominant factor

  3. Algorithm of Energy Efficiency Improvement for Intelligent Devices in Railway Transport

    Directory of Open Access Journals (Sweden)

    Beinaroviča Anna

    2016-07-01

    Full Text Available The present paper deals with the use of systems and devices with artificial intelligence in the motor vehicle driving. The main objective of transport operations is a transportation planning with minimum energy consumption. There are various methods for energy saving, and the paper discusses one of them – proper planning of transport operations. To gain proper planning it is necessary to involve the system and devices with artificial intelligence. They will display possible developments in the choice of one or another transport plan. Consequently, it can be supposed how much the plan is effective against the spent energy. The intelligent device considered in this paper consists of an algorithm, a database, and the internet for the connection to other intelligent devices. The main task of the target function is to minimize the total downtime at intermediate stations. A specific unique PHP-based computer model was created. It uses the MySQL database for simulation data storage and processing. Conclusions based on the experiments were made. The experiments showed that after optimization, a train can pass intermediate stations without making multiple stops breaking and accelerating, which leads to decreased energy consumption.

  4. EFFECT OF SWEEP ANGLE ON THE VORTICAL FLOW OVER DELTA WINGS AT AN ANGLE OF ATTACK OF 10°

    Directory of Open Access Journals (Sweden)

    JAMES BRETT

    2014-12-01

    Full Text Available CFD simulations have been used to analyse the vortical flows over sharp edged delta wings with differing sweep angles under subsonic conditions at an angle of attack of 10°. RANS simulations were validated against experimental data for a 65° sweep wing, with a flat cross-section, and the steadiness of the flow field was assessed by comparing the results against unsteady URANS and DES simulations. To assess the effect of sweep angle on the flow field, a range of sweep angles from 65° to 43° were simulated. For moderate sweep wings the primary vortex was observed to detach from the leading edge, undergoing vortex breakdown, and a weaker, replacement, "shadow" vortex was formed. The shadow vortex was observed for sweep angles of 50° and less, and resulted in reduced lift production near the wing tips loss of the stronger primary vortex.

  5. Study of plasma turbulence by ultrafast sweeping reflectometry on the Tore Supra Tokamak

    International Nuclear Information System (INIS)

    Hornung, Gregoire

    2013-01-01

    The performance of a fusion reactor is closely related to the turbulence present in the plasma. The latter is responsible for anomalous transport of heat and particles that degrades the confinement. The measure and characterization of turbulence in tokamak plasma is therefore essential to the understanding and control of this phenomenon. Among the available diagnostics, the sweeping reflectometer installed on Tore Supra allows to access the plasma density fluctuations from the edge to the centre of the plasma discharge with a fine spatial (mm) and temporal resolution (μs), that is of the order of the characteristic turbulence scales.This thesis consisted in the characterization of plasma turbulence in Tore Supra by ultrafast sweeping reflectometry measurements. Correlation analyses are used to quantify the spatial and temporal scales of turbulence as well as their radial velocity. In the first part, the characterization of turbulence properties from the reconstructed plasma density profiles is discussed, in particular through a comparative study with Langmuir probe data. Then, a parametric study is presented, highlighting the effect of collisionality on turbulence, an interpretation of which is proposed in terms of the stabilization of trapped electron turbulence in the confined plasma. Finally, it is shown how additional heating at ion cyclotron frequency produces a significant though local modification of the turbulence in the plasma near the walls, resulting in a strong increase of the structure velocity and a decrease of the correlation time. The supposed effect of rectified potentials generated by the antenna is investigated via numerical simulations. (author) [fr

  6. Acceleration methods for assembly-level transport calculations

    International Nuclear Information System (INIS)

    Adams, Marvin L.; Ramone, Gilles

    1995-01-01

    A family acceleration methods for the iterations that arise in assembly-level transport calculations is presented. A single iteration in these schemes consists of a transport sweep followed by a low-order calculation which is itself a simplified transport problem. It is shown that a previously-proposed method fitting this description is unstable in two and three dimensions. It is presented a family of methods and shown that some members are unconditionally stable. (author). 8 refs, 4 figs, 4 tabs

  7. Flux-corrected transport principles, algorithms, and applications

    CERN Document Server

    Löhner, Rainald; Turek, Stefan

    2012-01-01

    Many modern high-resolution schemes for Computational Fluid Dynamics trace their origins to the Flux-Corrected Transport (FCT) paradigm. FCT maintains monotonicity using a nonoscillatory low-order scheme to determine the bounds for a constrained high-order approximation. This book begins with historical notes by J.P. Boris and D.L. Book who invented FCT in the early 1970s. The chapters that follow describe the design of fully multidimensional FCT algorithms for structured and unstructured grids, limiting for systems of conservation laws, and the use of FCT as an implicit subgrid scale model. The second edition presents 200 pages of additional material. The main highlights of the three new chapters include: FCT-constrained interpolation for Arbitrary Lagrangian-Eulerian methods, an optimization-based approach to flux correction, and FCT simulations of high-speed flows on overset grids. Addressing students and researchers, as well as CFD practitioners, the book is focused on computational aspects and contains m...

  8. A fast, parallel algorithm to solve the basic fluvial erosion/transport equations

    Science.gov (United States)

    Braun, J.

    2012-04-01

    Quantitative models of landform evolution are commonly based on the solution of a set of equations representing the processes of fluvial erosion, transport and deposition, which leads to predict the geometry of a river channel network and its evolution through time. The river network is often regarded as the backbone of any surface processes model (SPM) that might include other physical processes acting at a range of spatial and temporal scales along hill slopes. The basic laws of fluvial erosion requires the computation of local (slope) and non-local (drainage area) quantities at every point of a given landscape, a computationally expensive operation which limits the resolution of most SPMs. I present here an algorithm to compute the various components required in the parameterization of fluvial erosion (and transport) and thus solve the basic fluvial geomorphic equation, that is very efficient because it is O(n) (the number of required arithmetic operations is linearly proportional to the number of nodes defining the landscape), and is fully parallelizable (the computation cost decreases in a direct inverse proportion to the number of processors used to solve the problem). The algorithm is ideally suited for use on latest multi-core processors. Using this new technique, geomorphic problems can be solved at an unprecedented resolution (typically of the order of 10,000 X 10,000 nodes) while keeping the computational cost reasonable (order 1 sec per time step). Furthermore, I will show that the algorithm is applicable to any regular or irregular representation of the landform, and is such that the temporal evolution of the landform can be discretized by a fully implicit time-marching algorithm, making it unconditionally stable. I will demonstrate that such an efficient algorithm is ideally suited to produce a fully predictive SPM that links observationally based parameterizations of small-scale processes to the evolution of large-scale features of the landscapes on

  9. A field-sweep/field-lock system for superconducting magnets--Application to high-field EPR.

    Science.gov (United States)

    Maly, Thorsten; Bryant, Jeff; Ruben, David; Griffin, Robert G

    2006-12-01

    We describe a field-lock/field-sweep system for the use in superconducting magnets. The system is based on a commercially available field mapping unit and a custom designed broad-band 1H NMR probe. The NMR signal of a small water sample is used in a feedback loop to set and control the magnetic field to high accuracy. The current instrumental configuration allows field sweeps of +/-0.4 T and a resolution of up to 10(-5) T (0.1 G) and the performance of the system is demonstrated in a high-field electron paramagnetic resonance (EPR) application. The system should also be of utility in other experiments requiring precise and reproducible sweeps of the magnetic field such as DNP, ENDOR or PELDOR.

  10. A Field-Sweep/Field-Lock System for Superconducting Magnets-Application to High-Field EPR

    Science.gov (United States)

    Maly, Thorsten; Bryant, Jeff; Ruben, David; Griffin, Robert G.

    2007-01-01

    We describe a field-lock/field-sweep system for the use in superconducting magnets. The system is based on a commercially available field mapping unit and a custom designed broad-band 1H-NMR probe. The NMR signal of a small water sample is used in a feedback loop to set and control the magnetic field to high accuracy. The current instrumental configuration allows field sweeps of ± 0.4 T and a resolution of up to 10-5 T (0.1 G) and the performance of the system is demonstrated in a high-field electron paramagnetic resonance (EPR) application. The system should also be of utility in other experiments requiring precise and reproducible sweeps of the magnetic field such as DNP, ENDOR or PELDOR. PMID:17027306

  11. A parallel algorithm for solving the multidimensional within-group discrete ordinates equations with spatial domain decomposition - 104

    International Nuclear Information System (INIS)

    Zerr, R.J.; Azmy, Y.Y.

    2010-01-01

    A spatial domain decomposition with a parallel block Jacobi solution algorithm has been developed based on the integral transport matrix formulation of the discrete ordinates approximation for solving the within-group transport equation. The new methodology abandons the typical source iteration scheme and solves directly for the fully converged scalar flux. Four matrix operators are constructed based upon the integral form of the discrete ordinates equations. A single differential mesh sweep is performed to construct these operators. The method is parallelized by decomposing the problem domain into several smaller sub-domains, each treated as an independent problem. The scalar flux of each sub-domain is solved exactly given incoming angular flux boundary conditions. Sub-domain boundary conditions are updated iteratively, and convergence is achieved when the scalar flux error in all cells meets a pre-specified convergence criterion. The method has been implemented in a computer code that was then employed for strong scaling studies of the algorithm's parallel performance via a fixed-size problem in tests ranging from one domain up to one cell per sub-domain. Results indicate that the best parallel performance compared to source iterations occurs for optically thick, highly scattering problems, the variety that is most difficult for the traditional SI scheme to solve. Moreover, the minimum execution time occurs when each sub-domain contains a total of four cells. (authors)

  12. Characteristics of a gas-jet transport system for an on-line isotope separator

    International Nuclear Information System (INIS)

    Kawade, K.; Yamamoto, H.; Amano, H.; Hanada, M.; Katoh, T.; Okano, K.; Kawase, Y.; Fujiwara, I.

    1982-01-01

    Basic characteristics of a gas-jet transport system for an on-line isotope separator have been investigated using a 252 Cf source and a 235 U fission source. The transport efficiency of fission products through a capillary has been measured to be about 60% for the 235 U fission source. The sweep-out time of fission products through a target chamber and the transit time through a capillary have been measured for He, N 2 and CO 2 gases at several pressures. The measured sweep-out times have been almost equal to the exchange over time of the gas. The transit times have been found to be reasonably predicted by calculations. The transport system has been incorporated into the KUR-ISOL and is used for the study of short-lived nuclei. (orig.)

  13. Effects of Sweep Angle on the Boundary-Layer Stability Characteristics of an Untapered Wing at Low Speeds

    Science.gov (United States)

    Boltz, Frederick W.; Kenyon, George C.; Allen, Clyde Q.

    1960-01-01

    An investigation was conducted in the Ames 12-Foot Low-Turbulence Pressure Tunnel to determine the effects of sweep on the boundary-layer stability characteristics of an untapered variable-sweep wing having an NACA 64(2)A015 section normal to the leading edge. Pressure distribution and transition were measured on the wing at low speeds at sweep angles of 0, 10, 20, 30, 40, and 50 deg. and at angles of attack from -3 to 3 deg. The investigation also included flow-visualization studies on the surface at sweep angles from 0 to 50 deg. and total pressure surveys in the boundary layer at a sweep angle of 30 deg. for angles of attack from -12 to 0 deg. It was found that sweep caused premature transition on the wing under certain conditions. This effect resulted from the formation of vortices in the boundary layer when a critical combination of sweep angle, pressure gradient, and stream Reynolds number was attained. A useful parameter in indicating the combined effect of these flow variables on vortex formation and on beginning transition is the crossflow Reynolds number. The critical values of crossflow Reynolds number for vortex formation found in this investigation range from about 135 to 190 and are in good agreement with those reported in previous investigations. The values of crossflow Reynolds number for beginning transitions were found to be between 190 and 260. For each condition (i.e., development of vortices and initiation of transition at a given location) the lower values in the specified ranges were obtained with a light coating of flow-visualization material on the surface. A method is presented for the rapid computation of crossflow Reynolds number on any swept surface for which the pressure distribution is known. From calculations based on this method, it was found that the maximum values of crossflow Reynolds number are attained under conditions of a strong pressure gradient and at a sweep angle of about 50 deg. Due to the primary dependence on pressure

  14. Turbulent flow structures and aeolian sediment transport over a barchan sand dune

    Science.gov (United States)

    Wiggs, G. F. S.; Weaver, C. M.

    2012-03-01

    The turbulent structure of airflow over a barchan sand dune is determined using quadrant analysis of wind velocity data derived from sonic anemometers. Results indicate an increased frequency of ejection and sweep events in the toe region of the dune, characteristic of the turbulent bursting process. In contrast, at the crest there was a significant increase in the occurrence of outward interactions. Combined with high frequency saltation data our analyses show that turbulent structures characterised by a positive streamwise fluctuating velocity (+u‧ sweeps at the toe and outward interactions at the crest) have a dominant influence on sand transport on the dune, together accounting for up to 83% and 95% of transporting events at the toe and crest respectively.

  15. Simulation and theory of spontaneous TAE frequency sweeping

    International Nuclear Information System (INIS)

    Wang Ge; Berk, H.L.

    2012-01-01

    A simulation model, based on the linear tip model of Rosenbluth, Berk and Van Dam (RBV), is developed to study frequency sweeping of toroidal Alfvén eigenmodes (TAEs). The time response of the background wave in the RBV model is given by a Volterra integral equation. This model captures the properties of TAE waves both in the gap and in the continuum. The simulation shows that phase space structures form spontaneously at frequencies close to the linearly predicted frequency, due to resonant particle–wave interactions and background dissipation. The frequency sweeping signals are found to chirp towards the upper and lower continua. However, the chirping signals penetrate only the lower continuum, whereupon the frequency chirps and mode amplitude increases in synchronism to produce an explosive solution. An adiabatic theory describing the evolution of a chirping signal is developed which replicates the chirping dynamics of the simulation in the lower continuum. This theory predicts that a decaying chirping signal will terminate at the upper continuum though in the numerical simulation the hole disintegrates before the upper continuum is reached. (paper)

  16. Simulation and theory of spontaneous TAE frequency sweeping

    Science.gov (United States)

    Wang, Ge; Berk, H. L.

    2012-09-01

    A simulation model, based on the linear tip model of Rosenbluth, Berk and Van Dam (RBV), is developed to study frequency sweeping of toroidal Alfvén eigenmodes (TAEs). The time response of the background wave in the RBV model is given by a Volterra integral equation. This model captures the properties of TAE waves both in the gap and in the continuum. The simulation shows that phase space structures form spontaneously at frequencies close to the linearly predicted frequency, due to resonant particle-wave interactions and background dissipation. The frequency sweeping signals are found to chirp towards the upper and lower continua. However, the chirping signals penetrate only the lower continuum, whereupon the frequency chirps and mode amplitude increases in synchronism to produce an explosive solution. An adiabatic theory describing the evolution of a chirping signal is developed which replicates the chirping dynamics of the simulation in the lower continuum. This theory predicts that a decaying chirping signal will terminate at the upper continuum though in the numerical simulation the hole disintegrates before the upper continuum is reached.

  17. Transport energy modeling with meta-heuristic harmony search algorithm, an application to Turkey

    Energy Technology Data Exchange (ETDEWEB)

    Ceylan, Huseyin; Ceylan, Halim; Haldenbilen, Soner; Baskan, Ozgur [Department of Civil Engineering, Engineering Faculty, Pamukkale University, Muh. Fak. Denizli 20017 (Turkey)

    2008-07-15

    This study proposes a new method for estimating transport energy demand using a harmony search (HS) approach. HArmony Search Transport Energy Demand Estimation (HASTEDE) models are developed taking population, gross domestic product and vehicle kilometers as an input. The HASTEDE models are in forms of linear, exponential and quadratic mathematical expressions and they are applied to Turkish Transportation sector energy consumption. Optimum or near-optimum values of the HS parameters are obtained with sensitivity analysis (SA). Performance of all models is compared with the Ministry of Energy and Natural Resources (MENR) projections. Results showed that HS algorithm may be used for energy modeling, but SA is required to obtain best values of the HS parameters. The quadratic form of HASTEDE will overestimate transport sector energy consumption by about 26% and linear and exponential forms underestimate by about 21% when they are compared with the MENR projections. This may happen due to the modeling procedure and selected parameters for models, but determining the upper and lower values of transportation sector energy consumption will provide a framework and flexibility for setting up energy policies. (author)

  18. Presentation of a Modified Boustrophedon Decomposition Algorithm for Optimal Configuration of Flat Fields to use in Path Planning Systems of Agricultural Vehicles

    Directory of Open Access Journals (Sweden)

    R Goudarzi

    2018-03-01

    Full Text Available Introduction The demand of pre-determined optimal coverage paths in agricultural environments have been increased due to the growing application of field robots and autonomous field machines. Also coverage path planning problem (CPP has been extensively studied in robotics and many algorithms have been provided in many topics, but differences and limitations in agriculture lead to several different heuristic and modified adaptive methods from robotics. In this paper, a modified and enhanced version of currently used decomposition algorithm in robotics (boustrophedon cellular decomposition has been presented as a main part of path planning systems of agricultural vehicles. Developed algorithm is based on the parallelization of the edges of the polygon representing the environment to satisfy the requirements of the problem as far as possible. This idea is based on "minimum facing to the cost making condition" in turn, it is derived from encounter concept as a basis of cost making factors. Materials and Methods Generally, a line termed as a slice in boustrophedon cellular decomposition (BCD, sweeps an area in a pre-determined direction and decomposes the area only at critical points (where two segments can be extended to top and bottom of the point. Furthermore, sweep line direction does not change until the decomposition finish. To implement the BCD for parallelization method, two modifications were applied in order to provide a modified version of the boustrophedon cellular decomposition (M-BCD. In the first modification, the longest edge (base edge is targeted, and sweep line direction is set in line with the base edge direction (sweep direction is set perpendicular to the sweep line direction. Then Sweep line moves through the environment and stops at the first (nearest critical point. Next sweep direction will be the same as previous, If the length of those polygon's newly added edges, during the decomposition, are less than or equal to the

  19. A new interpretation of distortion artifacts in sweep measurements

    DEFF Research Database (Denmark)

    Torras Rosell, Antoni; Jacobsen, Finn

    2011-01-01

    The characterization of acoustical spaces by means of impulse response measurements is often biased by the nonlinear behavior of the loudspeaker used to excite the system under test. In this context the distortion immunity provided by the sweep technique has been investigated. The results show...

  20. A Parallel Sweeping Preconditioner for Heterogeneous 3D Helmholtz Equations

    KAUST Repository

    Poulson, Jack

    2013-05-02

    A parallelization of a sweeping preconditioner for three-dimensional Helmholtz equations without large cavities is introduced and benchmarked for several challenging velocity models. The setup and application costs of the sequential preconditioner are shown to be O(γ2N4/3) and O(γN logN), where γ(ω) denotes the modestly frequency-dependent number of grid points per perfectly matched layer. Several computational and memory improvements are introduced relative to using black-box sparse-direct solvers for the auxiliary problems, and competitive runtimes and iteration counts are reported for high-frequency problems distributed over thousands of cores. Two open-source packages are released along with this paper: Parallel Sweeping Preconditioner (PSP) and the underlying distributed multifrontal solver, Clique. © 2013 Society for Industrial and Applied Mathematics.

  1. The Effects of Sweeping Jet Actuator Parameters on Flow Separation Control

    Science.gov (United States)

    Koklu, Mehti

    2015-01-01

    A parametric experimental study was performed with sweeping jet actuators (fluidic oscillators) to determine their effectiveness in controlling flow separation on an adverse pressure gradient ramp. Actuator parameters that were investigated include blowing coefficients, operation mode, pitch and spreading angles, streamwise location, aspect ratio, and scale. Surface pressure measurements and surface oil flow visualization were used to characterize the effects of these parameters on the actuator performance. 2D Particle Image Velocimetry measurements of the flow field over the ramp and hot-wire measurements of the actuator's jet flow were also obtained for selective cases. In addition, the sweeping jet actuators were compared to other well-known flow control techniques such as micro-vortex generators, steady blowing, and steady vortex-generating jets. The results confirm that the sweeping jet actuators are more effective than steady blowing and steady vortex-generating jets. The results also suggest that an actuator with a larger spreading angle placed closer to the location where the flow separates provides better performance. For the cases tested, an actuator with an aspect ratio, which is the width/depth of the actuator throat, of 2 was found to be optimal. For a fixed momentum coefficient, decreasing the aspect ratio to 1 produced weaker vortices while increasing the aspect ratio to 4 reduced coverage area. Although scaling down the actuator (based on the throat dimensions) from 0.25 inch x 0.125 inch to 0.15 inch x 0.075 inch resulted in similar flow control performance, scaling down the actuator further to 0.075 inch x 0.0375 inch reduced the actuator efficiency by reducing the coverage area and the amount of mixing in the near-wall region. The results of this study provide insight that can be used to design and select the optimal sweeping jet actuator configuration for flow control applications.

  2. Fast sweeping methods for hyperbolic systems of conservation laws at steady state II

    Science.gov (United States)

    Engquist, Björn; Froese, Brittany D.; Tsai, Yen-Hsi Richard

    2015-04-01

    The idea of using fast sweeping methods for solving stationary systems of conservation laws has previously been proposed for efficiently computing solutions with sharp shocks. We further develop these methods to allow for a more challenging class of problems including problems with sonic points, shocks originating in the interior of the domain, rarefaction waves, and two-dimensional systems. We show that fast sweeping methods can produce higher-order accuracy. Computational results validate the claims of accuracy, sharp shock curves, and optimal computational efficiency.

  3. A discrete element model for soil-sweep interaction in three different soils

    DEFF Research Database (Denmark)

    Chen, Y; Munkholm, Lars Juhl; Nyord, Tavs

    2013-01-01

    . To serve the model development, the sweep was tested in three different soils (coarse sand, loamy sand, and sandy loam). In the tests, soil cutting forces (draught and vertical forces) and soil disturbance characteristics (soil cross-section disturbance and surface deformation) resulting from the sweep...... were measured. The measured draught and vertical forces were used in calibrations of the most sensitive model parameter, particle stiffness. The calibrated particle stiffness was 0.75 × 103 N m−1 for the coarse sand, 2.75 × 103 N m−1 for the loamy sand, and 6 × 103 N m−1 for the sandy loam...

  4. Parallel Algorithms for Monte Carlo Particle Transport Simulation on Exascale Computing Architectures

    Science.gov (United States)

    Romano, Paul Kollath

    Monte Carlo particle transport methods are being considered as a viable option for high-fidelity simulation of nuclear reactors. While Monte Carlo methods offer several potential advantages over deterministic methods, there are a number of algorithmic shortcomings that would prevent their immediate adoption for full-core analyses. In this thesis, algorithms are proposed both to ameliorate the degradation in parallel efficiency typically observed for large numbers of processors and to offer a means of decomposing large tally data that will be needed for reactor analysis. A nearest-neighbor fission bank algorithm was proposed and subsequently implemented in the OpenMC Monte Carlo code. A theoretical analysis of the communication pattern shows that the expected cost is O( N ) whereas traditional fission bank algorithms are O(N) at best. The algorithm was tested on two supercomputers, the Intrepid Blue Gene/P and the Titan Cray XK7, and demonstrated nearly linear parallel scaling up to 163,840 processor cores on a full-core benchmark problem. An algorithm for reducing network communication arising from tally reduction was analyzed and implemented in OpenMC. The proposed algorithm groups only particle histories on a single processor into batches for tally purposes---in doing so it prevents all network communication for tallies until the very end of the simulation. The algorithm was tested, again on a full-core benchmark, and shown to reduce network communication substantially. A model was developed to predict the impact of load imbalances on the performance of domain decomposed simulations. The analysis demonstrated that load imbalances in domain decomposed simulations arise from two distinct phenomena: non-uniform particle densities and non-uniform spatial leakage. The dominant performance penalty for domain decomposition was shown to come from these physical effects rather than insufficient network bandwidth or high latency. The model predictions were verified with

  5. Procedures for waste management from street sweeping and stormwater systems.

    Science.gov (United States)

    2016-05-01

    Street sweeping and storm water system cleaning activities are conducted regularly by ODOT to comply with NPDES permit requirements and to ensure roadway safety. Once collected, these materials are classified as solid waste and require cost-effective...

  6. Grain boundary sweeping and liquefaction-induced fission product behavior in nuclear fuel under severe-core damage accident conditions

    International Nuclear Information System (INIS)

    Rest, J.

    1984-05-01

    The theoretical FASTGRASS-VFP model has been used in the interpretation of fission gas, iodine, tellurium, and cesium release from: (1) irradiated high-burnup LWR fuel in a flowing steam atmosphere during high-temperature, in-cell heating tests performed at Oak Ridge National Laboratory; and (2) trace-irradiated and high-burnup LWR fuel during severe-fuel-damage (SFD) tests performed in the PBF reactor in Idaho. A theory of grain boundary sweeping of gas bubbles, gas bubble behavior during fuel liquefaction (destruction of grain boundaries due to formation of a U-rich melt phase), and U-Zr eutectic melting has been included within the FASTGRASS-VFP formalism. Results of the analyses demonstrate that intragranular fission product behavior during both types of tests can be interpreted in terms of a grain-growth/grain-boundary-sweeping mechanism that enhances the flow of fission products from within the grains to the grain boundaries. Whereas fuel liquefaction leads to an enhanced release of fission products in trace-irradiated fuel, the occurrence of fuel liquefaction in high-burnup fuel can degrade fission product release. This phenomenon is due in part to reduced gas-bubble mobilities in a viscous medium as compared to vapor transport, and in part to a degradation of grain growth rates and the subsequent decrease in grain-boundary sweeping of intragranular fission products into the liquefied lamina. The analysis shows that total UO 2 dissolution due to eutectic melting leads to increased release for both trace-irradiated and high-burnup fuel. The FASTGRASS-VFP predictions, measured release rates from the above tests, and previously published release rates are compared and differences between fission product behavior in trace-irradiated and in high-burnup fuel are highlighted

  7. Limits on the Efficiency of Event-Based Algorithms for Monte Carlo Neutron Transport

    Energy Technology Data Exchange (ETDEWEB)

    Romano, Paul K.; Siegel, Andrew R.

    2017-04-16

    The traditional form of parallelism in Monte Carlo particle transport simulations, wherein each individual particle history is considered a unit of work, does not lend itself well to data-level parallelism. Event-based algorithms, which were originally used for simulations on vector processors, may offer a path toward better utilizing data-level parallelism in modern computer architectures. In this study, a simple model is developed for estimating the efficiency of the event-based particle transport algorithm under two sets of assumptions. Data collected from simulations of four reactor problems using OpenMC was then used in conjunction with the models to calculate the speedup due to vectorization as a function of two parameters: the size of the particle bank and the vector width. When each event type is assumed to have constant execution time, the achievable speedup is directly related to the particle bank size. We observed that the bank size generally needs to be at least 20 times greater than vector size in order to achieve vector efficiency greater than 90%. When the execution times for events are allowed to vary, however, the vector speedup is also limited by differences in execution time for events being carried out in a single event-iteration. For some problems, this implies that vector effciencies over 50% may not be attainable. While there are many factors impacting performance of an event-based algorithm that are not captured by our model, it nevertheless provides insights into factors that may be limiting in a real implementation.

  8. PARTRACK - A particle tracking algorithm for transport and dispersion of solutes in a sparsely fractured rock

    International Nuclear Information System (INIS)

    Svensson, Urban

    2001-04-01

    A particle tracking algorithm, PARTRACK, that simulates transport and dispersion in a sparsely fractured rock is described. The main novel feature of the algorithm is the introduction of multiple particle states. It is demonstrated that the introduction of this feature allows for the simultaneous simulation of Taylor dispersion, sorption and matrix diffusion. A number of test cases are used to verify and demonstrate the features of PARTRACK. It is shown that PARTRACK can simulate the following processes, believed to be important for the problem addressed: the split up of a tracer cloud at a fracture intersection, channeling in a fracture plane, Taylor dispersion and matrix diffusion and sorption. From the results of the test cases, it is concluded that PARTRACK is an adequate framework for simulation of transport and dispersion of a solute in a sparsely fractured rock

  9. Variation sweep rate cyclic voltammetry on the capacitance electrode activated carbon/PVDF with polymer electrolyte

    Science.gov (United States)

    Rohmawati, L.; Setyarsih, W.; Nurjannah, T.

    2018-03-01

    Sweep rate of the process voltammetry cyclic characterization is very influential towards the electrode capacitance value, especially on activated carbon electrodes/PVDF. A simple method of this research by use a mixing for electrode activated carbon/10 wt. % PVDF and the separator is made of a polymer electrolyte (PVA/H3PO4) by a sol gel method. The prototype supercapacitor is made in the form of a sandwich with a separator placed between two electrodes. Electrodes and separators are arranged in layers at a pressure of 1500 psi, then heated at 50°C for 10 minutes. Next done cyclic voltammetry in a potential range of -1 V to 1 V with a sweep rate of 5 mV/s, 10 mV/s, 20 mV/s, 25 mV/s and 50 mV/s. This results of curves voltammogram is reversible, the most wide curve on the sweep rate of 5 mV/s and most narrow curve on a sweep rate of 50 mV/s. Supercapacitor capacitance values obtained by 86 F/g, 43 F/g, 21 F/g, 16 F/g, and 8 F/g.

  10. Global restructuring of the CPM-2 transport algorithm for vector and parallel processing

    International Nuclear Information System (INIS)

    Vujic, J.L.; Martin, W.R.

    1989-01-01

    The CPM-2 code is an assembly transport code based on the collision probability (CP) method. It can in principle be applied to global reactor problems, but its excessive computational demands prevent this application. Therefore, a new transport algorithm for CPM-2 has been developed for vector-parallel architectures, which has resulted in an overall factor of 20 speedup (wall clock) on the IBM 3090-600E. This paper presents the detailed results of this effort as well as a brief description of ongoing effort to remove some of the modeling limitations in CPM-2 that inhibit its use for global applications, such as the use of the pure CP treatment and the assumption of isotropic scattering

  11. Influence of additives and impurities in sweep gas and solid tritium release behaviour from lithium ceramics (review)

    International Nuclear Information System (INIS)

    Tanaka, Satoru

    1991-01-01

    Tritium release from solid breeding material is affected by small amounts of additives or impurities in the sweep gas or solid itself. Addition of hydrogen or water vapor to the sweep gas is reported to enhance the surface reaction of tritium release. Doping to solid breeder with elements of different valence from lithium has a possibility to improve tritium diffusion in the solid. Surface reaction and migration behavior in bulk are believed to be also affected by impurities in the sweep gas and in the solid. In order to model tritium release behavior in the blanket of fusion reactor, the mechanism of interaction with these additives or impurities must be quantitatively formulated. However, the mechanism of these remains to be elucidated. In this paper effects of these additives and impurities on tritium migration are reviewed. The mechanism of surface reaction for He+H 2 sweep gas is also discussed. (orig.)

  12. Exact solutions for oscillatory shear sweep behaviors of complex fluids from the Oldroyd 8-constant framework

    Science.gov (United States)

    Saengow, Chaimongkol; Giacomin, A. Jeffrey

    2018-03-01

    In this paper, we provide a new exact framework for analyzing the most commonly measured behaviors in large-amplitude oscillatory shear flow (LAOS), a popular flow for studying the nonlinear physics of complex fluids. Specifically, the strain rate sweep (also called the strain sweep) is used routinely to identify the onset of nonlinearity. By the strain rate sweep, we mean a sequence of LAOS experiments conducted at the same frequency, performed one after another, with increasing shear rate amplitude. In this paper, we give exact expressions for the nonlinear complex viscosity and the corresponding nonlinear complex normal stress coefficients, for the Oldroyd 8-constant framework for oscillatory shear sweeps. We choose the Oldroyd 8-constant framework for its rich diversity of popular special cases (we list 18 of these). We evaluate the Fourier integrals of our previous exact solution to get exact expressions for the real and imaginary parts of the complex viscosity, and for the complex normal stress coefficients, as functions of both test frequency and shear rate amplitude. We explore the role of infinite shear rate viscosity on strain rate sweep responses for the special case of the corotational Jeffreys fluid. We find that raising η∞ raises the real part of the complex viscosity and lowers the imaginary. In our worked examples, we thus first use the corotational Jeffreys fluid, and then, for greater accuracy, we use the Johnson-Segalman fluid, to describe the strain rate sweep response of molten atactic polystyrene. For our comparisons with data, we use the Spriggs relations to generalize the Oldroyd 8-constant framework to multimode. Our generalization yields unequivocally, a longest fluid relaxation time, used to assign Weissenberg and Deborah numbers to each oscillatory shear flow experiment. We then locate each experiment in the Pipkin space.

  13. TIME CALIBRATED OSCILLOSCOPE SWEEP CIRCUIT

    Science.gov (United States)

    Smith, V.L.; Carstensen, H.K.

    1959-11-24

    An improved time calibrated sweep circuit is presented, which extends the range of usefulness of conventional oscilloscopes as utilized for time calibrated display applications in accordance with U. S. Patent No. 2,832,002. Principal novelty resides in the provision of a pair of separate signal paths, each of which is phase and amplitude adjustable, to connect a high-frequency calibration oscillator to the output of a sawtooth generator also connected to the respective horizontal deflection plates of an oscilloscope cathode ray tube. The amplitude and phase of the calibration oscillator signals in the two signal paths are adjusted to balance out feedthrough currents capacitively coupled at high frequencies of the calibration oscillator from each horizontal deflection plate to the vertical plates of the cathode ray tube.

  14. Flow field characteristics of impinging sweeping jets: TR-PIV measurement

    Science.gov (United States)

    Wen, Xin; Peng, Di; Liu, Yingzheng; Tang, Hui

    2017-11-01

    Influence of Reynolds number of sweeping jets on its impinging flow fields was extensively investigated in a water tank. Toward this end, a fluidic oscillator was specially designed to produce spatially sweeping jets which imping on a flat plate. Six Reynolds numbers were tested by controlling the supply flow rate of the fluidic oscillator. Impinging flow fields were captured by time-resolved Particle Image Velocimetry (TR-PIV) measurement. Reference signals were extracted from the flow fields for phase reconstruction. The oscillating flow fields with super-harmonic frequency at different regions were discussed in term of the phase-averaged velocity, vorticity and turbulent velocity. Dynamic mode decomposition (DMD) was used to capture the most-energetic flow patterns with distinct frequencies. By projecting the phase-averaged flow fields onto a reduced basis of DMD modes, the phase correlation between the distinct flow patterns were analyzed under different Reynolds numbers.

  15. Parallel ray tracing for one-dimensional discrete ordinate computations

    International Nuclear Information System (INIS)

    Jarvis, R.D.; Nelson, P.

    1996-01-01

    The ray-tracing sweep in discrete-ordinates, spatially discrete numerical approximation methods applied to the linear, steady-state, plane-parallel, mono-energetic, azimuthally symmetric, neutral-particle transport equation can be reduced to a parallel prefix computation. In so doing, the often severe penalty in convergence rate of the source iteration, suffered by most current parallel algorithms using spatial domain decomposition, can be avoided while attaining parallelism in the spatial domain to whatever extent desired. In addition, the reduction implies parallel algorithm complexity limits for the ray-tracing sweep. The reduction applies to all closed, linear, one-cell functional (CLOF) spatial approximation methods, which encompasses most in current popular use. Scalability test results of an implementation of the algorithm on a 64-node nCube-2S hypercube-connected, message-passing, multi-computer are described. (author)

  16. Limits on the efficiency of event-based algorithms for Monte Carlo neutron transport

    Directory of Open Access Journals (Sweden)

    Paul K. Romano

    2017-09-01

    Full Text Available The traditional form of parallelism in Monte Carlo particle transport simulations, wherein each individual particle history is considered a unit of work, does not lend itself well to data-level parallelism. Event-based algorithms, which were originally used for simulations on vector processors, may offer a path toward better utilizing data-level parallelism in modern computer architectures. In this study, a simple model is developed for estimating the efficiency of the event-based particle transport algorithm under two sets of assumptions. Data collected from simulations of four reactor problems using OpenMC was then used in conjunction with the models to calculate the speedup due to vectorization as a function of the size of the particle bank and the vector width. When each event type is assumed to have constant execution time, the achievable speedup is directly related to the particle bank size. We observed that the bank size generally needs to be at least 20 times greater than vector size to achieve vector efficiency greater than 90%. When the execution times for events are allowed to vary, the vector speedup is also limited by differences in the execution time for events being carried out in a single event-iteration.

  17. Residual sweeping errors in turbulent particle pair diffusion in a Lagrangian diffusion model.

    Science.gov (United States)

    Malik, Nadeem A

    2017-01-01

    Thomson, D. J. & Devenish, B. J. [J. Fluid Mech. 526, 277 (2005)] and others have suggested that sweeping effects make Lagrangian properties in Kinematic Simulations (KS), Fung et al [Fung J. C. H., Hunt J. C. R., Malik N. A. & Perkins R. J. J. Fluid Mech. 236, 281 (1992)], unreliable. However, such a conclusion can only be drawn under the assumption of locality. The major aim here is to quantify the sweeping errors in KS without assuming locality. Through a novel analysis based upon analysing pairs of particle trajectories in a frame of reference moving with the large energy containing scales of motion it is shown that the normalized integrated error [Formula: see text] in the turbulent pair diffusivity (K) due to the sweeping effect decreases with increasing pair separation (σl), such that [Formula: see text] as σl/η → ∞; and [Formula: see text] as σl/η → 0. η is the Kolmogorov turbulence microscale. There is an intermediate range of separations 1 < σl/η < ∞ in which the error [Formula: see text] remains negligible. Simulations using KS shows that in the swept frame of reference, this intermediate range is large covering almost the entire inertial subrange simulated, 1 < σl/η < 105, implying that the deviation from locality observed in KS cannot be atributed to sweeping errors. This is important for pair diffusion theory and modeling. PACS numbers: 47.27.E?, 47.27.Gs, 47.27.jv, 47.27.Ak, 47.27.tb, 47.27.eb, 47.11.-j.

  18. Outcome of Membrane Sweeping in Reducing Induction Rates in Post-Date Pregnancies

    International Nuclear Information System (INIS)

    Saleem, U.; Mustafa, N.; Akhtar, S.

    2013-01-01

    Objectives: To determine the effectiveness of membrane sweeping in reducing need for induction of labour in post-date pregnancies and to enlist types and frequencies of complications experienced with membrane sweeping. Study Design: Randomized Control trial. Setting and Duration of Study: The study was carried out at Department of Obstetrics and Gynaecology, Combined Military Hospital, Lahore from February 2007 to April 2008. Patients and Methods: One hundred primi or second gravidas with uncomplicated singleton pregnancies having cephalic presentation at 40+1-5 weeks of gestation were enrolled after informed consent, and divided randomly into two groups of fifty each. Biophysical profile of 8/8 for each case was ensured. Group A underwent membrane sweeping while group B did not. All patients not having spontaneous labour were induced at 40+5 weeks. Data regarding number of patients having spontaneous labour or induction of labour was recorded. Mode of delivery either vaginal or cesarean birth was also recorded. In group A occurence of complications i.e vaginal bleeding or leaking, discomfort, irregular pains, fever and neonatal sepsis was recorded. Results: The difference in rate of spontaneous labor, induction rate and mode of delivery was insignificant between both the groups (p>0.05). In group A, 44% felt discomfort, 4% had bleeding per vaginum, 2% had leaking per vaginum and 28% had more than one complication. There were no cases of maternal or neonatal sepsis. Twenty percent did not have any side effects. Conclusion: Sweeping of membranes is not effective in reducing induction rates in post dates pregnancies. It does not improve the spontaneous labour rate and there is no effect on the mode of delivery. Therefore, any potential benefits of this intervention must be balanced against risk of maternal discomfort and other adverse effects. (author)

  19. Sweeping Jet Actuators - A New Design Tool for High Lift Generation

    Science.gov (United States)

    Graff, Emilio; Seele, Roman; Lin, John C.; Wygnanski, Israel

    2013-01-01

    Active Flow Control (AFC) experiments performed at the Caltech Lucas Wind Tunnel on a generic airplane vertical tail model proved the effectiveness of sweeping jets in improving the control authority of a rudder. The results indicated that a momentum coefficient (C(sub u)) of approximately 2% increased the side force in excess of 50% at the maximum conventional rudder deflection angle in the absence of yaw. However, sparsely distributed actuators providing a collective C(sub u) approx. = 0.1% were able to increase the side force in excess of 20%. This result is achieved by reducing the spanwise flow along the swept back rudder and its success is attributed to the large sweep back angle of the vertical tail. This current effort was sponsored by the NASA Environmentally Responsible Aviation (ERA) project.

  20. Effect of Sweep on Cavity Flow Fields at Subsonic and Transonic Speeds

    Science.gov (United States)

    Tracy, Maureen B.; Plentovich, Elizabeth B.; Hemsch, Michael J.; Wilcox, Floyd J.

    2012-01-01

    An experimental investigation was conducted in the NASA Langley 7 x 10-Foot High Speed Tunnel (HST) to study the effect of leading- and trailing-edge sweep on cavity flow fields for a range of cavity length-to-height (l/h) ratios. The free-stream Mach number was varied from 0.2 to 0.8. The cavity had a depth of 0.5 inches, a width of 2.5 inches, and a maximum length of 12.0 inches. The leading- and trailing-edge sweep was adjusted using block inserts to achieve leading edge sweep angles of 65 deg, 55 deg, 45 deg, 35 deg, and 0 deg. The fore and aft cavity walls were always parallel. The aft wall of the cavity was remotely positioned to achieve a range of length-to-depth ratios. Fluctuating- and static-pressure data were obtained on the floor of the cavity. The fluctuating pressure data were used to determine whether or not resonance occurred in the cavity rather than to provide a characterization of the fluctuating pressure field. Qualitative surface flow visualization was obtained using a technique in which colored water was introduced into the model through static-pressure orifices. A complete tabulation of the mean static-pressure data for the swept leading edge cavities is included.

  1. Particle Communication and Domain Neighbor Coupling: Scalable Domain Decomposed Algorithms for Monte Carlo Particle Transport

    Energy Technology Data Exchange (ETDEWEB)

    O' Brien, M. J.; Brantley, P. S.

    2015-01-20

    In order to run Monte Carlo particle transport calculations on new supercomputers with hundreds of thousands or millions of processors, care must be taken to implement scalable algorithms. This means that the algorithms must continue to perform well as the processor count increases. In this paper, we examine the scalability of:(1) globally resolving the particle locations on the correct processor, (2) deciding that particle streaming communication has finished, and (3) efficiently coupling neighbor domains together with different replication levels. We have run domain decomposed Monte Carlo particle transport on up to 221 = 2,097,152 MPI processes on the IBM BG/Q Sequoia supercomputer and observed scalable results that agree with our theoretical predictions. These calculations were carefully constructed to have the same amount of work on every processor, i.e. the calculation is already load balanced. We also examine load imbalanced calculations where each domain’s replication level is proportional to its particle workload. In this case we show how to efficiently couple together adjacent domains to maintain within workgroup load balance and minimize memory usage.

  2. Highway Passenger Transport Based Express Parcel Service Network Design: Model and Algorithm

    Directory of Open Access Journals (Sweden)

    Yuan Jiang

    2017-01-01

    Full Text Available Highway passenger transport based express parcel service (HPTB-EPS is an emerging business that uses unutilised room of coach trunk to ship parcels between major cities. While it is reaping more and more express market, the managers are facing difficult decisions to design the service network. This paper investigates the HPTB-EPS network design problem and analyses the time-space characteristics of such network. A mixed-integer programming model is formulated integrating the service decision, frequency, and network flow distribution. To solve the model, a decomposition-based heuristic algorithm is designed by decomposing the problem as three steps: construction of service network, service path selection, and distribution of network flow. Numerical experiment using real data from our partner company demonstrates the effectiveness of our model and algorithm. We found that our solution could reduce the total cost by up to 16.3% compared to the carrier’s solution. The sensitivity analysis demonstrates the robustness and flexibility of the solutions of the model.

  3. Analysis of some greedy algorithms for the single-sink fixed-charge transportation problem

    DEFF Research Database (Denmark)

    Görtz, Simon; Klose, Andreas

    2009-01-01

    -charge transportation problem. Nevertheless, just a few methods for solving this problem have been proposed in the literature. In this paper, some greedy heuristic solutions methods for the SSFCTP are investigated. It is shown that two greedy approaches for the SSFCTP known from the literature can be arbitrarily bad......, whereas an approximation algorithm proposed in the literature for the binary min-knapsack problem has a guaranteed worst case bound if adapted accordingly to the case of the SSFCTP....

  4. Suppression of nonlinear frequency-sweeping of resonant interchange modes in a magnetic dipole with applied radio frequency fields

    International Nuclear Information System (INIS)

    Maslovsky, D.; Levitt, B.; Mauel, M. E.

    2003-01-01

    Interchange instabilities excited by energetic electrons trapped by a magnetic dipole nonlinearly saturate and exhibit complex, coherent spectral characteristics and frequency sweeping [H. P. Warren and M. E. Mauel, Phys. Plasmas 2, 4185 (1995)]. When monochromatic radio frequency (rf) fields are applied in the range of 100-1000 MHz, the saturation behavior of the interchange instability changes dramatically. For applied fields of sufficient intensity and pulse-length, coherent interchange fluctuations are suppressed and frequency sweeping is eliminated. When rf fields are switched off, coherent frequency sweeping reappears. Since low frequency interchange instabilities preserve the electron's first and second adiabatic invariants, these observations can be interpreted as resulting from nonlinear resonant wave-particle interactions described within a particle phase-space, (ψ,φ), comprised of the third adiabatic invariant and the azimuthal angle. Self-consistent numerical simulation is used to study (1) the nonlinear development of the instability, (2) the radial mode structure of the interchange instability, and (3) the suppression of frequency sweeping. When the applied rf heating is modeled as an 'rf collisionality', the simulation reproduces frequency sweeping suppression and suggests an explanation for the observations that is consistent with Berk and co-workers [H. L. Berk et al., Phys. Plasmas 6, 3102 (1999)

  5. Dynamic airspace configuration algorithms for next generation air transportation system

    Science.gov (United States)

    Wei, Jian

    The National Airspace System (NAS) is under great pressure to safely and efficiently handle the record-high air traffic volume nowadays, and will face even greater challenge to keep pace with the steady increase of future air travel demand, since the air travel demand is projected to increase to two to three times the current level by 2025. The inefficiency of traffic flow management initiatives causes severe airspace congestion and frequent flight delays, which cost billions of economic losses every year. To address the increasingly severe airspace congestion and delays, the Next Generation Air Transportation System (NextGen) is proposed to transform the current static and rigid radar based system to a dynamic and flexible satellite based system. New operational concepts such as Dynamic Airspace Configuration (DAC) have been under development to allow more flexibility required to mitigate the demand-capacity imbalances in order to increase the throughput of the entire NAS. In this dissertation, we address the DAC problem in the en route and terminal airspace under the framework of NextGen. We develop a series of algorithms to facilitate the implementation of innovative concepts relevant with DAC in both the en route and terminal airspace. We also develop a performance evaluation framework for comprehensive benefit analyses on different aspects of future sector design algorithms. First, we complete a graph based sectorization algorithm for DAC in the en route airspace, which models the underlying air route network with a weighted graph, converts the sectorization problem into the graph partition problem, partitions the weighted graph with an iterative spectral bipartition method, and constructs the sectors from the partitioned graph. The algorithm uses a graph model to accurately capture the complex traffic patterns of the real flights, and generates sectors with high efficiency while evenly distributing the workload among the generated sectors. We further improve

  6. Analysing Infinite-State Systems by Combining Equivalence Reduction and the Sweep-Line Method

    DEFF Research Database (Denmark)

    Mailund, Thomas

    2002-01-01

    The sweep-line method is a state space exploration method for on-the-fly verification aimed at systems exhibiting progress. Presence of progress in the system makes it possible to delete certain states during state space generation, which reduces the memory used for storing the states. Unfortunat......The sweep-line method is a state space exploration method for on-the-fly verification aimed at systems exhibiting progress. Presence of progress in the system makes it possible to delete certain states during state space generation, which reduces the memory used for storing the states....... Unfortunately, the same progress that is used to improve memory performance in state space exploration often leads to an infinite state space: The progress in the system is carried over to the states resulting in infinitely many states only distinguished through the progress. A finite state space can...... property essential for the sweep-line method. We evaluate the new method on two case studies, showing significant improvements in performance, and we briefly discuss the new method in the context of Timed Coloured Petri Nets, where the “increasing global time” semantics can be exploited for more efficient...

  7. A two-dimensional regularization algorithm for density profile evaluation from broadband reflectometry

    International Nuclear Information System (INIS)

    Nunes, F.; Varela, P.; Silva, A.; Manso, M.; Santos, J.; Nunes, I.; Serra, F.; Kurzan, B.; Suttrop, W.

    1997-01-01

    Broadband reflectometry is a current technique that uses the round-trip group delays of reflected frequency-swept waves to measure density profiles of fusion plasmas. The main factor that may limit the accuracy of the reconstructed profiles is the interference of the probing waves with the plasma density fluctuations: plasma turbulence leads to random phase variations and magneto hydrodynamic activity produces mainly strong amplitude and phase modulations. Both effects cause the decrease, and eventually loss, of signal at some frequencies. Several data processing techniques can be applied to filter and/or interpolate noisy group delay data obtained from turbulent plasmas with a single frequency sweep. Here, we propose a more powerful algorithm performing two-dimensional regularization (in space and time) of data provided by multiple consecutive frequency sweeps, which leads to density profiles with improved accuracy. The new method is described and its application to simulated data corrupted by noise and missing data is considered. It is shown that the algorithm improves the identification of slowly varying plasma density perturbations by attenuating the effect of fast fluctuations and noise contained in experimental data. First results obtained with this method in ASDEX Upgrade tokamak are presented. copyright 1997 American Institute of Physics

  8. Modelling for near-surface interaction of lithium ceramics and sweep-gas by use of cellular automation

    International Nuclear Information System (INIS)

    Shimura, K.; Terai, T.; Yamawaki, M.; Yamaguchi, K.

    2003-01-01

    Tritium release from the lithium ceramics as a fusion reactor breeder material is strongly affected by the composition of the sweep-gas as result of its influences with the material's surface. The typical surface processes which play important roles are adsorption, desorption and interaction between vacancy site and the constituents of the sweep-gas. Among a large number of studies and models, yet it seems to be difficult to model the overall behaviour of those processes due to its complex time-transient nature. In the present work the coarse grained atomic simulation based on the Cellular Automaton (CA) is used to model the dynamics of near-surface interaction between Li 2 O surface and sweep-gas that is consisting of a noble gas, hydrogen gas and water vapour. (author)

  9. Combinatorial theory of the semiclassical evaluation of transport moments II: Algorithmic approach for moment generating functions

    Energy Technology Data Exchange (ETDEWEB)

    Berkolaiko, G. [Department of Mathematics, Texas A and M University, College Station, Texas 77843-3368 (United States); Kuipers, J. [Institut für Theoretische Physik, Universität Regensburg, D-93040 Regensburg (Germany)

    2013-12-15

    Electronic transport through chaotic quantum dots exhibits universal behaviour which can be understood through the semiclassical approximation. Within the approximation, calculation of transport moments reduces to codifying classical correlations between scattering trajectories. These can be represented as ribbon graphs and we develop an algorithmic combinatorial method to generate all such graphs with a given genus. This provides an expansion of the linear transport moments for systems both with and without time reversal symmetry. The computational implementation is then able to progress several orders further than previous semiclassical formulae as well as those derived from an asymptotic expansion of random matrix results. The patterns observed also suggest a general form for the higher orders.

  10. Acidic sweep gas with carbonic anhydrase coated hollow fiber membranes synergistically accelerates CO2 removal from blood.

    Science.gov (United States)

    Arazawa, D T; Kimmel, J D; Finn, M C; Federspiel, W J

    2015-10-01

    The use of extracorporeal carbon dioxide removal (ECCO2R) is well established as a therapy for patients suffering from acute respiratory failure. Development of next generation low blood flow (carbonic anhydrase (CA) immobilized bioactive hollow fiber membrane (HFM) which significantly accelerates CO2 removal from blood in model gas exchange devices by converting bicarbonate to CO2 directly at the HFM surface. This present study tested the hypothesis that dilute sulfur dioxide (SO2) in oxygen sweep gas could further increase CO2 removal by creating an acidic microenvironment within the diffusional boundary layer adjacent to the HFM surface, facilitating dehydration of bicarbonate to CO2. CA was covalently immobilized onto poly (methyl pentene) (PMP) HFMs through glutaraldehyde activated chitosan spacers, potted in model gas exchange devices (0.0151 m(2)) and tested for CO2 removal rate with oxygen (O2) sweep gas and a 2.2% SO2 in oxygen sweep gas mixture. Using pure O2 sweep gas, CA-PMP increased CO2 removal by 31% (258 mL/min/m(2)) compared to PMP (197 mL/min/m(2)) (Premoval by 17% (230 mL/min/m(2)) compared to pure oxygen sweep gas control (Premoval increased by 109% (411 mL/min/m(2)) (Premoval, and when used in combination with bioactive CA-HFMs has a synergistic effect to more than double CO2 removal while maintaining physiologic pH. Through these technologies the next generation of intravascular and paracorporeal respiratory assist devices can remove more CO2 with smaller blood contacting surface areas. A clinical need exists for more efficient respiratory assist devices which utilize low blood flow rates (removal efficiency by shifting equilibrium from bicarbonate to gaseous CO2, through either a bioactive carbonic anhydrase enzyme coating or bulk blood acidification with lactic acid. In this study we demonstrate a novel approach to local blood acidification using an acidified sweep gas in combination with a bioactive coating to more than double CO2 removal

  11. Effect of elasticity during viscoelastic polymer flooding : a possible mechanism of increasing the sweep efficiency

    Energy Technology Data Exchange (ETDEWEB)

    Urbissinova, T.S.; Trivedi, J.J.; Kuru, E. [Alberta Univ., Edmonton, AB (Canada). Dept. of Civil and Environmental Engineering

    2010-12-15

    This paper discussed a laboratory experiment undertaken to study how the elasticity of polymer-based fluids affects microscopic sweep efficiency, which has implications for enhanced oil recovery processes. In a series of experiments, polymer solutions with the same shear viscosity but notably different elastic characteristics were injected through a mineral-oil-saturated sandpack. The experiments involved a special core holder that was designed to simulate radial flow. The solution was injected via a perforated injection line located in the centre of the cell, and fluids were produced by way of 2 production lines located at the periphery. The shear rate used in the experiments was within the range of field applications. Using polymer solutions with similar shear viscosity behaviour and different elasticity allowed the effect of elasticity on sweep efficiency to be singled out. It was concluded that adjusting the molecular weight distribution of the solution at a constant shear viscosity and polymer concentration could improve the sweep efficiency of a polymeric fluid. The higher-elasticity polymer solution had a higher resistance to flow through porous media, resulting in better sweep efficiency and lower residual oil saturation. The objective of the study was to isolate elasticity from the other parameters that affect displacement efficiency to show the individual effect of elasticity on oil recovery. 20 refs., 5 tabs., 14 figs.

  12. The DANTE Boltzmann transport solver: An unstructured mesh, 3-D, spherical harmonics algorithm compatible with parallel computer architectures

    International Nuclear Information System (INIS)

    McGhee, J.M.; Roberts, R.M.; Morel, J.E.

    1997-01-01

    A spherical harmonics research code (DANTE) has been developed which is compatible with parallel computer architectures. DANTE provides 3-D, multi-material, deterministic, transport capabilities using an arbitrary finite element mesh. The linearized Boltzmann transport equation is solved in a second order self-adjoint form utilizing a Galerkin finite element spatial differencing scheme. The core solver utilizes a preconditioned conjugate gradient algorithm. Other distinguishing features of the code include options for discrete-ordinates and simplified spherical harmonics angular differencing, an exact Marshak boundary treatment for arbitrarily oriented boundary faces, in-line matrix construction techniques to minimize memory consumption, and an effective diffusion based preconditioner for scattering dominated problems. Algorithm efficiency is demonstrated for a massively parallel SIMD architecture (CM-5), and compatibility with MPP multiprocessor platforms or workstation clusters is anticipated

  13. Lax-Friedrichs sweeping scheme for static Hamilton-Jacobi equations

    International Nuclear Information System (INIS)

    Kao, C.Y.; Osher, Stanley; Qian Jianliang

    2004-01-01

    We propose a simple, fast sweeping method based on the Lax-Friedrichs monotone numerical Hamiltonian to approximate viscosity solutions of arbitrary static Hamilton-Jacobi equations in any number of spatial dimensions. By using the Lax-Friedrichs numerical Hamiltonian, we can easily obtain the solution at a specific grid point in terms of its neighbors, so that a Gauss-Seidel type nonlinear iterative method can be utilized. Furthermore, by incorporating a group-wise causality principle into the Gauss-Seidel iteration by following a finite group of characteristics, we have an easy-to-implement, sweeping-type, and fast convergent numerical method. However, unlike other methods based on the Godunov numerical Hamiltonian, some computational boundary conditions are needed in the implementation. We give a simple recipe which enforces a version of discrete min-max principle. Some convergence analysis is done for the one-dimensional eikonal equation. Extensive 2-D and 3-D numerical examples illustrate the efficiency and accuracy of the new approach. To our knowledge, this is the first fast numerical method based on discretizing the Hamilton-Jacobi equation directly without assuming convexity and/or homogeneity of the Hamiltonian

  14. Lax-Friedrichs sweeping scheme for static Hamilton-Jacobi equations

    Science.gov (United States)

    Kao, Chiu Yen; Osher, Stanley; Qian, Jianliang

    2004-05-01

    We propose a simple, fast sweeping method based on the Lax-Friedrichs monotone numerical Hamiltonian to approximate viscosity solutions of arbitrary static Hamilton-Jacobi equations in any number of spatial dimensions. By using the Lax-Friedrichs numerical Hamiltonian, we can easily obtain the solution at a specific grid point in terms of its neighbors, so that a Gauss-Seidel type nonlinear iterative method can be utilized. Furthermore, by incorporating a group-wise causality principle into the Gauss-Seidel iteration by following a finite group of characteristics, we have an easy-to-implement, sweeping-type, and fast convergent numerical method. However, unlike other methods based on the Godunov numerical Hamiltonian, some computational boundary conditions are needed in the implementation. We give a simple recipe which enforces a version of discrete min-max principle. Some convergence analysis is done for the one-dimensional eikonal equation. Extensive 2-D and 3-D numerical examples illustrate the efficiency and accuracy of the new approach. To our knowledge, this is the first fast numerical method based on discretizing the Hamilton-Jacobi equation directly without assuming convexity and/or homogeneity of the Hamiltonian.

  15. Communication strategies for angular domain decomposition of transport calculations on message passing multiprocessors

    International Nuclear Information System (INIS)

    Azmy, Y.Y.

    1997-01-01

    The effect of three communication schemes for solving Arbitrarily High Order Transport (AHOT) methods of the Nodal type on parallel performance is examined via direct measurements and performance models. The target architecture in this study is Oak Ridge National Laboratory's 128 node Paragon XP/S 5 computer and the parallelization is based on the Parallel Virtual Machine (PVM) library. However, the conclusions reached can be easily generalized to a large class of message passing platforms and communication software. The three schemes considered here are: (1) PVM's global operations (broadcast and reduce) which utilizes the Paragon's native corresponding operations based on a spanning tree routing; (2) the Bucket algorithm wherein the angular domain decomposition of the mesh sweep is complemented with a spatial domain decomposition of the accumulation process of the scalar flux from the angular flux and the convergence test; (3) a distributed memory version of the Bucket algorithm that pushes the spatial domain decomposition one step farther by actually distributing the fixed source and flux iterates over the memories of the participating processes. Their conclusion is that the Bucket algorithm is the most efficient of the three if all participating processes have sufficient memories to hold the entire problem arrays. Otherwise, the third scheme becomes necessary at an additional cost to speedup and parallel efficiency that is quantifiable via the parallel performance model

  16. Block Tridiagonal Matrices in Electronic Structure Calculations

    DEFF Research Database (Denmark)

    Petersen, Dan Erik

    in the Landauer–Büttiker ballistic transport regime. These calculations concentrate on determining the so– called Green’s function matrix, or portions thereof, which is the inverse of a block tridiagonal general complex matrix. To this end, a sequential algorithm based on Gaussian elimination named Sweeps...

  17. Sweeping total reflection X-ray fluorescence optimisation to monitor the metallic contamination into IC manufacturing

    International Nuclear Information System (INIS)

    Borde, Yannick; Danel, Adrien; Roche, Agnes; Veillerot, Marc

    2008-01-01

    Among the methods available on the market today to control as metallic contamination in integrated circuit manufacturing, Sweeping Total reflection X-ray Fluorescence mode appears a very good method, providing fast and entire wafer mapping. With the goal of a pertinent use of Sweeping Total reflection X-ray Fluorescence in advanced Integrated Circuit manufacturing this work discusses how acceptable levels of contamination specified by the production (low levels to be detected) can be taken into account. The relation between measurement results (surface coverage, throughput, low limit of detection, limit of quantification, quantification of localized contamination) and Sweeping Total reflection X-ray Fluorescence parameters (number of measurement points and integration time per point) is presented in details. In particular, a model is proposed to explain the mismatch between actual surface contamination in a localized spot on wafer and Total reflection X-ray Fluorescence reading. Both calibration and geometric issues have been taken into account

  18. A second order discontinuous Galerkin fast sweeping method for Eikonal equations

    Science.gov (United States)

    Li, Fengyan; Shu, Chi-Wang; Zhang, Yong-Tao; Zhao, Hongkai

    2008-09-01

    In this paper, we construct a second order fast sweeping method with a discontinuous Galerkin (DG) local solver for computing viscosity solutions of a class of static Hamilton-Jacobi equations, namely the Eikonal equations. Our piecewise linear DG local solver is built on a DG method developed recently [Y. Cheng, C.-W. Shu, A discontinuous Galerkin finite element method for directly solving the Hamilton-Jacobi equations, Journal of Computational Physics 223 (2007) 398-415] for the time-dependent Hamilton-Jacobi equations. The causality property of Eikonal equations is incorporated into the design of this solver. The resulting local nonlinear system in the Gauss-Seidel iterations is a simple quadratic system and can be solved explicitly. The compactness of the DG method and the fast sweeping strategy lead to fast convergence of the new scheme for Eikonal equations. Extensive numerical examples verify efficiency, convergence and second order accuracy of the proposed method.

  19. F--Ray: A new algorithm for efficient transport of ionizing radiation

    Science.gov (United States)

    Mao, Yi; Zhang, J.; Wandelt, B. D.; Shapiro, P. R.; Iliev, I. T.

    2014-04-01

    We present a new algorithm for the 3D transport of ionizing radiation, called F2-Ray (Fast Fourier Ray-tracing method). The transfer of ionizing radiation with long mean free path in diffuse intergalactic gas poses a special challenge to standard numerical methods which transport the radiation in position space. Standard methods usually trace each individual ray until it is fully absorbed by the intervening gas. If the mean free path is long, the computational cost and memory load are likely to be prohibitive. We have developed an algorithm that overcomes these limitations and is, therefore, significantly more efficient. The method calculates the transfer of radiation collectively, using the Fast Fourier Transform to convert radiation between position and Fourier spaces, so the computational cost will not increase with the number of ionizing sources. The method also automatically combines parallel rays with the same frequency at the same grid cell, thereby minimizing the memory requirement. The method is explicitly photon-conserving, i.e. the depletion of ionizing photons is guaranteed to equal the photoionizations they caused, and explicitly obeys the periodic boundary condition, i.e. the escape of ionizing photons from one side of a simulation volume is guaranteed to be compensated by emitting the same amount of photons into the volume through the opposite side. Together, these features make it possible to numerically simulate the transfer of ionizing photons more efficiently than previous methods. Since ionizing radiation such as the X-ray is responsible for heating the intergalactic gas when first stars and quasars form at high redshifts, our method can be applied to simulate thermal distribution, in addition to cosmic reionization, in three-dimensional inhomogeneous cosmological density field.

  20. A Fuzzy Approach Using Generalized Dinkelbach’s Algorithm for Multiobjective Linear Fractional Transportation Problem

    Directory of Open Access Journals (Sweden)

    Nurdan Cetin

    2014-01-01

    Full Text Available We consider a multiobjective linear fractional transportation problem (MLFTP with several fractional criteria, such as, the maximization of the transport profitability like profit/cost or profit/time, and its two properties are source and destination. Our aim is to introduce MLFTP which has not been studied in literature before and to provide a fuzzy approach which obtain a compromise Pareto-optimal solution for this problem. To do this, first, we present a theorem which shows that MLFTP is always solvable. And then, reducing MLFTP to the Zimmermann’s “min” operator model which is the max-min problem, we construct Generalized Dinkelbach’s Algorithm for solving the obtained problem. Furthermore, we provide an illustrative numerical example to explain this fuzzy approach.

  1. Methodology for coupling computational fluid dynamics and integral transport neutronics

    International Nuclear Information System (INIS)

    Thomas, J. W.; Zhong, Z.; Sofu, T.; Downar, T. J.

    2004-01-01

    The CFD code STAR-CD was coupled to the integral transport code DeCART in order to provide high-fidelity, full physics reactor simulations. An interface program was developed to perform the tasks of mapping the STAR-CD mesh to the DeCART mesh, managing all communication between STAR-CD and DeCART, and monitoring the convergence of the coupled calculations. The interface software was validated by comparing coupled calculation results with those obtained using an independently developed interface program. An investigation into the convergence characteristics of coupled calculations was performed using several test models on a multiprocessor LINUX cluster. The results indicate that the optimal convergence of the coupled field calculation depends on several factors, to include the tolerance of the STAR-CD solution and the number of DeCART transport sweeps performed before exchanging data between codes. Results for a 3D, multi-assembly PWR problem on 12 PEs of the LINUX cluster indicate the best performance is achieved when the STAR-CD tolerance and number of DeCART transport sweeps are chosen such that the two fields converge at approximately the same rate. (authors)

  2. Study of Near-Stall Flow Behavior in a Modern Transonic Fan with Composite Sweep

    Science.gov (United States)

    Hah, Chunill; Shin, Hyoun-Woo

    2011-01-01

    Detailed flow behavior in a modern transonic fan with a composite sweep is investigated in this paper. Both unsteady Reynolds-averaged Navier-Stokes (URANS) and Large Eddy Simulation (LES) methods are applied to investigate the flow field over a wide operating range. The calculated flow fields are compared with the data from an array of high-frequency response pressure transducers embedded in the fan casing. The current study shows that a relatively fine computational grid is required to resolve the flow field adequately and to calculate the pressure rise across the fan correctly. The calculated flow field shows detailed flow structure near the fan rotor tip region. Due to the introduction of composite sweep toward the rotor tip, the flow structure at the rotor tip is much more stable compared to that of the conventional blade design. The passage shock stays very close to the leading edge at the rotor tip even at the throttle limit. On the other hand, the passage shock becomes stronger and detaches earlier from the blade passage at the radius where the blade sweep is in the opposite direction. The interaction between the tip clearance vortex and the passage shock becomes intense as the fan operates toward the stall limit, and tip clearance vortex breakdown occurs at near-stall operation. URANS calculates the time-averaged flow field fairly well. Details of measured RMS static pressure are not calculated with sufficient accuracy with URANS. On the other hand, LES calculates details of the measured unsteady flow features in the current transonic fan with composite sweep fairly well and reveals the flow mechanism behind the measured unsteady flow field.

  3. SWEEP, a computer program for the analysis of CDA energetics in liquid metal reactors

    International Nuclear Information System (INIS)

    Suk, Soo Dong; Lee, Yong Bum; Hahn, Do Hee

    2003-12-01

    The SWEEP computer code was developed in this study to evaluate the work energy arising from two-phase expansion of fuel or sodium during core disruptive accidents in KALIMER. In the SWEEP program, scoping calculations with a modified Bethe-Tait method is first carried out using SCHAMBETA module to provide the initial thermodynamic conditions for the subsequent analyses to estimate the mechanical work energy generated in the reactor system. To estimate the work energy due to fuel-vapor expansion, a bounding approach is adopted to calculate the work potential assuming isentropic expansion to atmospheric pressure during super-prompt critical power excursions. Work potentials are also calculated in the SWEEP code for sodium expansion using the simple thermodynamic models including the infinite heat transfer model during expansion(Hicks and Menzies method) or more realistic zero heat transfer model for a typical initial condition of core disruptive accident. Core disruptive accidents have been investigated at Korea Atomic Energy Research Institute(KAERI) as part of the work to demonstrate the inherent and ultimate safety of conceptual design of the Korea Advanced Liquid Metal Reactor(KALIMER), a 150 MWe pool-type sodium cooled prototype fast reactor that uses U-TRU-Zr metallic fuel

  4. Algorithmic choices in WARP – A framework for continuous energy Monte Carlo neutron transport in general 3D geometries on GPUs

    International Nuclear Information System (INIS)

    Bergmann, Ryan M.; Vujić, Jasmina L.

    2015-01-01

    Highlights: • WARP, a GPU-accelerated Monte Carlo neutron transport code, has been developed. • The NVIDIA OptiX high-performance ray tracing library is used to process geometric data. • The unionized cross section representation is modified for higher performance. • Reference remapping is used to keep the GPU busy as neutron batch population reduces. • Reference remapping is done using a key-value radix sort on neutron reaction type. - Abstract: In recent supercomputers, general purpose graphics processing units (GPGPUs) are a significant faction of the supercomputer’s total computational power. GPGPUs have different architectures compared to central processing units (CPUs), and for Monte Carlo neutron transport codes used in nuclear engineering to take advantage of these coprocessor cards, transport algorithms must be changed to execute efficiently on them. WARP is a continuous energy Monte Carlo neutron transport code that has been written to do this. The main thrust of WARP is to adapt previous event-based transport algorithms to the new GPU hardware; the algorithmic choices for all parts of which are presented in this paper. It is found that remapping history data references increases the GPU processing rate when histories start to complete. The main reason for this is that completed data are eliminated from the address space, threads are kept busy, and memory bandwidth is not wasted on checking completed data. Remapping also allows the interaction kernels to be launched concurrently, improving efficiency. The OptiX ray tracing framework and CUDPP library are used for geometry representation and parallel dataset-side operations, ensuring high performance and reliability

  5. Wind turbine rotor blade with in-plane sweep and devices using the same, and methods for making the same

    Science.gov (United States)

    Wetzel, Kyle Kristopher

    2014-06-24

    A wind turbine includes a rotor having a hub and at least one blade having a torsionally rigid root, an inboard section, and an outboard section. The inboard section has a forward sweep relative to an elastic axis of the blade and the outboard section has an aft sweep.

  6. Scaling of the susceptibility vs. magnetic-field sweep rate in Fe8 molecular magnet

    Science.gov (United States)

    Jordi, M.; Hernandez-Mínguez, A.; Hernandez, J. M.; Tejada, J.; Stroobants, S.; Vanacken, J.; Moshchalkov, V. V.

    2004-12-01

    The dependence of the magnetization reversal on the sweep rate of the applied magnetic field has been studied for single crystals of Fe8 magnetic molecules. Our experiments have been conducted at temperatures below 1 K and sweep rates of the magnetic field between 103 T/s to 104 T/s. The systematic shift of the values of the magnetic field at which the magnetization reversal occurs, indicates that this reversal process is not governed by the Landau-Zener transition model. Our data can be explained in terms of the superradiance emission model proposed by Chudnovsky and Garanin (Phys. Rev. Lett. 89 (2002) 157201).

  7. Beam pinging, sweeping, shaking, and electron/ion collecting, at the Proton Storage Ring

    International Nuclear Information System (INIS)

    Hardek, T.W.; Macek, R.J.; Plum, M.A.; Wang, T.S.F.

    1993-01-01

    We have built, installed and tested a pinger for use as a general diagnostic at the Los Alamos Proton Storage Ring (PSR). Two 4-m-long parallel-plate electrodes with a plate spacing of 10.2 cm provide kicks of up to 1.1 mrad. A pair of solid-state pulsers may be operated in a single-pulse mode for beam pinging (tune measurements) or in a burst mode at up to 700 kHz pulse rates for beam sweeping. During our 1992 operating period we used the pinger for beam sweeping, for beam shaking, for measuring the tune shift, and we have used it as an ion chamber. Using the pinger as an ion chamber during production conditions has yielded some surprising results

  8. Reverse spontaneous laser line sweeping in ytterbium fiber laser

    Czech Academy of Sciences Publication Activity Database

    Navrátil, Petr; Peterka, Pavel; Honzátko, Pavel; Kubeček, V.

    2017-01-01

    Roč. 14, č. 3 (2017), č. článku 035102. ISSN 1612-2011 R&D Projects: GA ČR(CZ) GA16-13306S Institutional support: RVO:67985882 ; RVO:68378271 Keywords : laser line sweeping * ytterbium * fiber lasers Subject RIV: BH - Optics, Masers, Lasers; BH - Optics, Masers, Lasers (FZU-D) OBOR OECD: Optics (including laser optics and quantum optics); Optics (including laser optics and quantum optics) (FZU-D) Impact factor: 2.537, year: 2016

  9. Determination of lysergic acid diethylamide (LSD) in mouse blood by capillary electrophoresis/ fluorescence spectroscopy with sweeping techniques in micellar electrokinetic chromatography.

    Science.gov (United States)

    Fang, Ching; Liu, Ju-Tsung; Chou, Shiu-Huey; Lin, Cheng-Huang

    2003-03-01

    The separation and on-line concentration of lysergic acid diethylamide (LSD) in mouse blood was achieved by means of capillary electrophoresis/fluorescence spectroscopy using sodium dodecyl sulfate (SDS) as the surfactant. Techniques involving on-line sample concentration, including sweeping micellar electrokinetic chromatography (sweeping-MEKC) and cation-selective exhaustive injection-sweep-micellar electrokinetic chromatography (CSEI-sweep-MEKC) were applied; the optimum on-line concentration and separation conditions were determined. In the analysis of an actual sample, LSD was found in a blood sample from a test mouse (0.1 mg LSD fed to a 20 g mouse; approximately 1/10 to the value of LD(50)). As a result, 120 and 30 ng/mL of LSD was detected at 20 and 60 min, respectively, after ingestion of the doses.

  10. Vertical-horizontal wells for depletion and sweep

    Energy Technology Data Exchange (ETDEWEB)

    Muraikhi, A. J.; Pham, T. R.; Liu, J. S.; Khatib, M. R.; Muhaish, A. S. [Saudi Aramco (Saudi Arabia)

    1998-12-31

    A well completion scheme currently in use in a thick, large, elongated carbonate anticline Middle-East oil reservoir is described. This method of well completion calls for a combination of an open hole horizontal section penetrating the top 10 feet of the reservoir and a cased or undisturbed vertical segment through the thick formation. The horizontal section is used for producing and the vertical segment is used for monitoring purposes. Field experience and supported reservoir simulation exercises have shown that the horizontal application is superior to conventional vertical completion both from the economic and from the sweep point of view. 4 refs., 12 figs.

  11. Signatures of soft sweeps across the Dt1 locus underlying determinate growth habit in soya bean [Glycine max (L.) Merr.].

    Science.gov (United States)

    Zhong, Limei; Yang, Qiaomei; Yan, Xin; Yu, Chao; Su, Liu; Zhang, Xifeng; Zhu, Youlin

    2017-09-01

    Determinate growth habit is an agronomically important trait associated with domestication in soya bean. Previous studies have demonstrated that the emergence of determinacy is correlated with artificial selection on four nonsynonymous mutations in the Dt1 gene. To better understand the signatures of the soft sweeps across the Dt1 locus and track the origins of the determinate alleles, we examined patterns of nucleotide variation in Dt1 and the surrounding genomic region of approximately 800 kb. Four local, asymmetrical hard sweeps on four determinate alleles, sized approximately 660, 120, 220 and 150 kb, were identified, which constitute the soft sweeps for the adaptation. These variable-sized sweeps substantially reflected the strength and timing of selection and indicated that the selection on the alleles had been completed rapidly within half a century. Statistics of EHH, iHS, H12 and H2/H1 based on haplotype data had the power to detect the soft sweeps, revealing distinct signatures of extensive long-range LD and haplotype homozygosity, and multiple frequent adaptive haplotypes. A haplotype network constructed for Dt1 and a phylogenetic tree based on its extended haplotype block implied independent sources of the adaptive alleles through de novo mutations or rare standing variation in quick succession during the selective phase, strongly supporting multiple origins of the determinacy. We propose that the adaptation of soya bean determinacy is guided by a model of soft sweeps and that this model might be indispensable during crop domestication or evolution. © 2017 The Authors. Molecular Ecology Published by John Wiley & Sons Ltd.

  12. From sweeping to the caress: similarities and discrepancies between human and non-human primates' pleasant touch

    Directory of Open Access Journals (Sweden)

    Laura Clara Grandi

    2016-09-01

    Full Text Available Affective touch plays a key role in affiliative behavior, offering a mechanism for the formation and maintenance of social bonds among conspecifics, both in humans and non-human primates. Furthermore, it has been speculated that the CT fiber system is a specific coding channel for affiliative touch that occurs during skin-to-skin interactions with conspecifics. In humans, this touch is commonly referred to as the caress, and its correlation with the CT fiber system has been widely demonstrated. It has been hypothesized that the sweeping touch that occurs during grooming in non-human primates may modulate the CT fibers, with recent preliminary studies on rhesus monkeys supporting this hypothesis. The present mini-review proposes a comparison between the pleasant touch, caress and sweeping of humans and non-human primates, respectively. The currently available data was therefore reviewed regarding i the correlation between pleasant touch and CT fibers both in humans and non-human primates, ii the autonomic effects, iii the encoding at the central nervous system, iv the development from early life to adulthood, and v the potential applications of pleasant touch in the daily lives of both humans and non-human primates. Moreover, by considering both the similarities and discrepancies between the human caress and non-human primate sweeping, a possible evolutionary mechanism can be proposed that has developed from sweeping as a utilitarian action with affiliative meaning among monkeys, to the caress as a purely affective gesture associated with humans.

  13. Lipschitz continuous data dependence of sweeping processes in BV spaces

    Czech Academy of Sciences Publication Activity Database

    Krejčí, Pavel; Roche, T.

    2011-01-01

    Roč. 15, č. 3 (2011), s. 637-650 ISSN 1531-3492 R&D Projects: GA ČR GAP201/10/2315; GA MŠk LC06052 Institutional research plan: CEZ:AV0Z10190503 Keywords : rate independence * discontinuous sweeping process * Kurzweil integral Subject RIV: BA - General Mathematics Impact factor: 0.921, year: 2011 http://aimsciences.org/journals/pdfs.jsp?paperID=5943&mode=full

  14. Three-dimensional discrete ordinates reactor assembly calculations on GPUs

    Energy Technology Data Exchange (ETDEWEB)

    Evans, Thomas M [ORNL; Joubert, Wayne [ORNL; Hamilton, Steven P [ORNL; Johnson, Seth R [ORNL; Turner, John A [ORNL; Davidson, Gregory G [ORNL; Pandya, Tara M [ORNL

    2015-01-01

    In this paper we describe and demonstrate a discrete ordinates sweep algorithm on GPUs. This sweep algorithm is nested within a multilevel comunication-based decomposition based on energy. We demonstrated the effectiveness of this algorithm on detailed three-dimensional critical experiments and PWR lattice problems. For these problems we show improvement factors of 4 6 over conventional communication-based, CPU-only sweeps. These sweep kernel speedups resulted in a factor of 2 total time-to-solution improvement.

  15. A Selfish Constraint Satisfaction Genetic Algorithms for Planning a Long-Distance Transportation Network

    Science.gov (United States)

    Onoyama, Takashi; Maekawa, Takuya; Kubota, Sen; Tsuruta, Setuso; Komoda, Norihisa

    To build a cooperative logistics network covering multiple enterprises, a planning method that can build a long-distance transportation network is required. Many strict constraints are imposed on this type of problem. To solve these strict-constraint problems, a selfish constraint satisfaction genetic algorithm (GA) is proposed. In this GA, each gene of an individual satisfies only its constraint selfishly, disregarding the constraints of other genes in the same individuals. Moreover, a constraint pre-checking method is also applied to improve the GA convergence speed. The experimental result shows the proposed method can obtain an accurate solution in a practical response time.

  16. Parallelized event chain algorithm for dense hard sphere and polymer systems

    International Nuclear Information System (INIS)

    Kampmann, Tobias A.; Boltz, Horst-Holger; Kierfeld, Jan

    2015-01-01

    We combine parallelization and cluster Monte Carlo for hard sphere systems and present a parallelized event chain algorithm for the hard disk system in two dimensions. For parallelization we use a spatial partitioning approach into simulation cells. We find that it is crucial for correctness to ensure detailed balance on the level of Monte Carlo sweeps by drawing the starting sphere of event chains within each simulation cell with replacement. We analyze the performance gains for the parallelized event chain and find a criterion for an optimal degree of parallelization. Because of the cluster nature of event chain moves massive parallelization will not be optimal. Finally, we discuss first applications of the event chain algorithm to dense polymer systems, i.e., bundle-forming solutions of attractive semiflexible polymers

  17. Moving Difference (MDIFF) Non-adiabatic rapid sweep (NARS) EPR of copper(II)

    Science.gov (United States)

    Hyde, James S.; Bennett, Brian; Kittell, Aaron W.; Kowalski, Jason M.; Sidabras, Jason W.

    2014-01-01

    Non Adiabatic Rapid Sweep (NARS) EPR spectroscopy has been introduced for application to nitroxide-labeled biological samples (AW Kittell et al, (2011)). Displays are pure absorption, and are built up by acquiring data in spectral segments that are concatenated. In this paper we extend the method to frozen solutions of copper-imidazole, a square planar copper complex with four in-plane nitrogen ligands. Pure absorption spectra are created from concatenation of 170 5-gauss segments spanning 850 G at 1.9 GHz. These spectra, however, are not directly useful since nitrogen superhyperfine couplings are barely visible. Application of the moving difference (MDIFF) algorithm to the digitized NARS pure absorption spectrum is used to produce spectra that are analogous to the first harmonic EPR. The signal intensity is about 4 times higher than when using conventional 100 kHz field modulation, depending on line shape. MDIFF not only filters the spectrum, but also the noise, resulting in further improvement of the SNR for the same signal acquisition time. The MDIFF amplitude can be optimized retrospectively, different spectral regions can be examined at different amplitudes, and an amplitude can be used that is substantially greater than the upper limit of the field modulation amplitude of a conventional EPR spectrometer, which improves the signal-to-noise ratio of broad lines. PMID:24036469

  18. A Fano cavity test for Monte Carlo proton transport algorithms

    International Nuclear Information System (INIS)

    Sterpin, Edmond; Sorriaux, Jefferson; Souris, Kevin; Vynckier, Stefaan; Bouchard, Hugo

    2014-01-01

    Purpose: In the scope of reference dosimetry of radiotherapy beams, Monte Carlo (MC) simulations are widely used to compute ionization chamber dose response accurately. Uncertainties related to the transport algorithm can be verified performing self-consistency tests, i.e., the so-called “Fano cavity test.” The Fano cavity test is based on the Fano theorem, which states that under charged particle equilibrium conditions, the charged particle fluence is independent of the mass density of the media as long as the cross-sections are uniform. Such tests have not been performed yet for MC codes simulating proton transport. The objectives of this study are to design a new Fano cavity test for proton MC and to implement the methodology in two MC codes: Geant4 and PENELOPE extended to protons (PENH). Methods: The new Fano test is designed to evaluate the accuracy of proton transport. Virtual particles with an energy ofE 0 and a mass macroscopic cross section of (Σ)/(ρ) are transported, having the ability to generate protons with kinetic energy E 0 and to be restored after each interaction, thus providing proton equilibrium. To perform the test, the authors use a simplified simulation model and rigorously demonstrate that the computed cavity dose per incident fluence must equal (ΣE 0 )/(ρ) , as expected in classic Fano tests. The implementation of the test is performed in Geant4 and PENH. The geometry used for testing is a 10 × 10 cm 2 parallel virtual field and a cavity (2 × 2 × 0.2 cm 3 size) in a water phantom with dimensions large enough to ensure proton equilibrium. Results: For conservative user-defined simulation parameters (leading to small step sizes), both Geant4 and PENH pass the Fano cavity test within 0.1%. However, differences of 0.6% and 0.7% were observed for PENH and Geant4, respectively, using larger step sizes. For PENH, the difference is attributed to the random-hinge method that introduces an artificial energy straggling if step size is not

  19. Pore-Scale Investigation of Micron-Size Polyacrylamide Elastic Microspheres (MPEMs) Transport and Retention in Saturated Porous Media

    KAUST Repository

    Yao, Chuanjin; Lei, Guanglun; Cathles, Lawrence M.; Steenhuis, Tammo S.

    2014-01-01

    Knowledge of micrometer-size polyacrylamide elastic microsphere (MPEM) transport and retention mechanisms in porous media is essential for the application of MPEMs as a smart sweep improvement and profile modification agent in improving oil recovery

  20. Performance of the SWEEP model affected by estimates of threshold friction velocity

    Science.gov (United States)

    The Wind Erosion Prediction System (WEPS) is a process-based model and needs to be verified under a broad range of climatic, soil, and management conditions. Occasional failure of the WEPS erosion submodel (Single-event Wind Erosion Evaluation Program or SWEEP) to simulate erosion in the Columbia Pl...

  1. A Global algorithm for linear radiosity

    OpenAIRE

    Sbert Cassasayas, Mateu; Pueyo Sánchez, Xavier

    1993-01-01

    A linear algorithm for radiosity is presented, linear both in time and storage. The new algorithm is based on previous work by the authors and on the well known algorithms for progressive radiosity and Monte Carlo particle transport.

  2. Acetate and phosphate anion adsorption linear sweep voltammograms simulated using density functional theory

    KAUST Repository

    Savizi, Iman Shahidi Pour; Janik, Michael J.

    2011-01-01

    ) electrode potential. Four models of the electrode potential are used including a simple vacuum slab model, an applied electric field model with and without the inclusion of a solvating water bi-layer, and the double reference model. The linear sweep

  3. Combustion systems and power plants incorporating parallel carbon dioxide capture and sweep-based membrane separation units to remove carbon dioxide from combustion gases

    Science.gov (United States)

    Wijmans, Johannes G [Menlo Park, CA; Merkel, Timothy C [Menlo Park, CA; Baker, Richard W [Palo Alto, CA

    2011-10-11

    Disclosed herein are combustion systems and power plants that incorporate sweep-based membrane separation units to remove carbon dioxide from combustion gases. In its most basic embodiment, the invention is a combustion system that includes three discrete units: a combustion unit, a carbon dioxide capture unit, and a sweep-based membrane separation unit. In a preferred embodiment, the invention is a power plant including a combustion unit, a power generation system, a carbon dioxide capture unit, and a sweep-based membrane separation unit. In both of these embodiments, the carbon dioxide capture unit and the sweep-based membrane separation unit are configured to be operated in parallel, by which we mean that each unit is adapted to receive exhaust gases from the combustion unit without such gases first passing through the other unit.

  4. Gas separation process using membranes with permeate sweep to remove CO.sub.2 from gaseous fuel combustion exhaust

    Science.gov (United States)

    Wijmans, Johannes G [Menlo Park, CA; Merkel, Timothy C [Menlo Park, CA; Baker, Richard W [Palo Alto, CA

    2012-05-15

    A gas separation process for treating exhaust gases from the combustion of gaseous fuels, and gaseous fuel combustion processes including such gas separation. The invention involves routing a first portion of the exhaust stream to a carbon dioxide capture step, while simultaneously flowing a second portion of the exhaust gas stream across the feed side of a membrane, flowing a sweep gas stream, usually air, across the permeate side, then passing the permeate/sweep gas back to the combustor.

  5. Cross-calibrating Spatial Positions of Light-viewing Diagnostics using Plasma Edge Sweeps in DIII-D

    International Nuclear Information System (INIS)

    Solomon, W.M.; Burrell, K.H.; Gohil, P.; Groebner, R.; Kaplan, D.

    2003-01-01

    An experimental technique is presented that permits diagnostics viewing light from the plasma edge to be spatially calibrated relative to one another. By sweeping the plasma edge, each chord of each diagnostic sweeps out a portion of the light emission profile. A nonlinear least-squares fit to such data provides superior cross-calibration of diagnostics located at different toroidal locations compared with simple surveying. Another advantage of the technique is that it can be used to monitor the position of viewing chords during an experimental campaign to ensure that alignment does not change over time. Moreover, should such a change occur, the data can still be cross-calibrated and its usefulness retained

  6. Initial tests of the dual-sweep streak camera system planned for APS particle-beam diagnostics

    International Nuclear Information System (INIS)

    Lumpkin, A.; Yang, B.; Gai, W.; Cieslik, W.

    1995-01-01

    Initial tests of a dual-sweep streak system planned for use on the Advanced Photon Source (APS) have been performed using assets of the Argonne Wakefield Accelerator (AWA) facility. The short light pulses from the photoelectric injector drive laser in both the visible (λ=496 nm, Δt∼1.5 ps (FWHM)), and the ultraviolet (λ=248 nm, Δt∼5 ps (FWHM)) were used. Both a UV-visible S20 photocathode streak tube and a UV-to-x-ray Au photocathode streak tube were tested. Calibration data with an etalon were also obtained. A sample of dual-sweep streak data using optical synchrotron radiation on the APS injector synchrotron is also presented

  7. Spall behaviors of high purity copper under sweeping detonation

    Energy Technology Data Exchange (ETDEWEB)

    Yang, Yang, E-mail: yangyanggroup@163.com [School of Material Science and Engineering, Central South University, Changsha 410083 (China); Institute of Fluid Physics, China Academy of Engineering Physics, Mianyang 621900 (China); National Key Laboratory of Explosion Science and Technology, Beijing Institute of Technology, Beijing 100081 (China); Key Laboratory of Nonferrous Metals Material Science and Engineering of Ministry of Education, Central South University, Changsha 410083 (China); Zhi-qiang, Peng; Xing-zhi, Chen [School of Material Science and Engineering, Central South University, Changsha 410083 (China); Key Laboratory of Nonferrous Metals Material Science and Engineering of Ministry of Education, Central South University, Changsha 410083 (China); Zhao-liang, Guo; Tie-gang, Tang; Hai-bo, Hu [Institute of Fluid Physics, China Academy of Engineering Physics, Mianyang 621900 (China); Qing-ming, Zhang [National Key Laboratory of Explosion Science and Technology, Beijing Institute of Technology, Beijing 100081 (China)

    2016-01-10

    Suites of sweeping detonation experiments were conducted to assess the spall behavior of high purity copper samples with different heat treatment histories. Incipient spall samples were obtained at different sweeping detonation condition. Metallographic and Electron Backscattered Diffraction (EBSD) analyses were performed on the soft-recovered samples. The effects of grain boundaries, grain size, crystal orientation and loading direction on the spall behaviors were discussed. Spall plane branching was found in the main spall plane of the damage samples. For similar microstructure, the area of voids increase with the increase of shock stress, and the coalescence of voids also become more obvious. Results from EBSD analysis show that the grain sizes were decreased and the grains were elongated along the direction of the plate width. Triple junctions composed of two or more general high angle boundaries are the preferred locations for intergranular damage. Voids prefer to nucleate in the grain boundaries composed of grain with high Taylor Factor (TF) than other grains. The damage areas in the grains with high TF are more severe. Boundaries close to perpendicular to the loading direction are more susceptible to void nucleation than the boundaries close to parallel to the loading direction, but the difference of voids nucleated in these two boundaries is less significant than the results obtained by plate impact experiment. It would be caused by the obliquity between the shock loading direction and the plate normal.

  8. Phylogeography of Nasonia vitripennis (Hymenoptera) indicates a mitochondrial-Wolbachia sweep in North America

    NARCIS (Netherlands)

    Raychoudhury, R.; Grillenberger, B. K.; Gadau, J.; Bijlsma, R.; van de Zande, L.; Werren, J. H.; Beukeboom, L. W.

    Here we report evidence of a mitochondrial-Wolbachia sweep in North American populations of the parasitoid wasp Nasonia vitripennis, a cosmopolitan species and emerging model organism for evolutionary and genetic studies. Analysis of the genetic variation of 89 N. vitripennis specimens from Europe

  9. On the effects of nonlinearities in room impulse response measurements with exponential sweeps

    DEFF Research Database (Denmark)

    Ciric, Dejan; Markovic, Milos; Mijic, Miomir

    2013-01-01

    In room impulse response measurements, there are some common disturbances that affect the measured results. These disturbances include nonlinearity, noise and time variance. In this paper, the effects of nonlinearities in the measurements with exponential sweep-sine signals are analyzed from diff...

  10. Potential effects of structural controls and street sweeping on stormwater loads to the lower Charles River, Massachusetts

    Science.gov (United States)

    Zarriello, Phillip J.; Breault, Robert F.; Weiskel, Peter K.

    2002-01-01

    The water quality of the lower Charles River is periodically impaired by combined sewer overflows (CSOs) and non-CSO stormwater runoff. This study examined the potential non-CSO load reductions of suspended solids, fecal coliform bacteria, total phosphorus, and total lead that could reasonably be achieved by implementation of stormwater best management practices, including both structural controls and systematic street sweeping. Structural controls were grouped by major physical or chemical process; these included infiltration-filtration (physical separation), biofiltration-bioretention (biological mechanisms), or detention-retention (physical settling). For each of these categories, upper and lower quartiles, median, and average removal efficiencies were compiled from three national databases of structural control performance. Removal efficiencies obtained indicated a wide range of performance. Removal was generally greatest for infiltration-filtration controls and suspended solids, and least for biofiltration-bioretention controls and fecal coliform bacteria. Street sweeping has received renewed interest as a water-quality control practice because of reported improvements in sweeper technology and the recognition that opportunities for implementing structural controls are limited in highly urbanized areas. The Stormwater Management Model that was developed by the U.S. Geological Survey for the lower Charles River Watershed was modified to simulate the effects of street sweeping in a single-family land-use basin. Constituent buildup and washoff variable values were calibrated to observed annual and storm-event loads. Once calibrated, the street sweeping model was applied to various permutations of four sweeper efficiencies and six sweeping frequencies that ranged from every day to once every 30 days. Reduction of constituent loads to the lower Charles River by the combined hypothetical practices of structural controls and street sweeping was estimated for a range

  11. Extended-bandwidth frequency sweeps of a distributed feedback laser using combined injection current and temperature modulation.

    Science.gov (United States)

    Hefferman, Gerald; Chen, Zhen; Wei, Tao

    2017-07-01

    This article details the generation of an extended-bandwidth frequency sweep using a single, communication grade distributed feedback (DFB) laser. The frequency sweep is generated using a two-step technique. In the first step, injection current modulation is employed as a means of varying the output frequency of a DFB laser over a bandwidth of 99.26 GHz. A digital optical phase lock loop is used to lock the frequency sweep speed during current modulation, resulting in a linear frequency chirp. In the second step, the temperature of the DFB laser is modulated, resulting in a shifted starting laser output frequency. A laser frequency chirp is again generated beginning at this shifted starting frequency, resulting in a frequency-shifted spectrum relative to the first recorded data. This process is then repeated across a range of starting temperatures, resulting in a series of partially overlapping, frequency-shifted spectra. These spectra are then aligned using cross-correlation and combined using averaging to form a single, broadband spectrum with a total bandwidth of 510.9 GHz. In order to investigate the utility of this technique, experimental testing was performed in which the approach was used as the swept-frequency source of a coherent optical frequency domain reflectometry system. This system was used to interrogate an optical fiber containing a 20 point, 1-mm pitch length fiber Bragg grating, corresponding to a period of 100 GHz. Using this technique, both the periodicity of the grating in the frequency domain and the individual reflector elements of the structure in the time domain were resolved, demonstrating the technique's potential as a method of extending the sweeping bandwidth of semiconductor lasers for frequency-based sensing applications.

  12. Extended-bandwidth frequency sweeps of a distributed feedback laser using combined injection current and temperature modulation

    Science.gov (United States)

    Hefferman, Gerald; Chen, Zhen; Wei, Tao

    2017-07-01

    This article details the generation of an extended-bandwidth frequency sweep using a single, communication grade distributed feedback (DFB) laser. The frequency sweep is generated using a two-step technique. In the first step, injection current modulation is employed as a means of varying the output frequency of a DFB laser over a bandwidth of 99.26 GHz. A digital optical phase lock loop is used to lock the frequency sweep speed during current modulation, resulting in a linear frequency chirp. In the second step, the temperature of the DFB laser is modulated, resulting in a shifted starting laser output frequency. A laser frequency chirp is again generated beginning at this shifted starting frequency, resulting in a frequency-shifted spectrum relative to the first recorded data. This process is then repeated across a range of starting temperatures, resulting in a series of partially overlapping, frequency-shifted spectra. These spectra are then aligned using cross-correlation and combined using averaging to form a single, broadband spectrum with a total bandwidth of 510.9 GHz. In order to investigate the utility of this technique, experimental testing was performed in which the approach was used as the swept-frequency source of a coherent optical frequency domain reflectometry system. This system was used to interrogate an optical fiber containing a 20 point, 1-mm pitch length fiber Bragg grating, corresponding to a period of 100 GHz. Using this technique, both the periodicity of the grating in the frequency domain and the individual reflector elements of the structure in the time domain were resolved, demonstrating the technique's potential as a method of extending the sweeping bandwidth of semiconductor lasers for frequency-based sensing applications.

  13. Implementation of a cell-wise block-Gauss-Seidel iterative method for SN transport on a hybrid parallel computer architecture

    International Nuclear Information System (INIS)

    Rosa, Massimiliano; Warsa, James S.; Perks, Michael

    2011-01-01

    We have implemented a cell-wise, block-Gauss-Seidel (bGS) iterative algorithm, for the solution of the S_n transport equations on the Roadrunner hybrid, parallel computer architecture. A compute node of this massively parallel machine comprises AMD Opteron cores that are linked to a Cell Broadband Engine™ (Cell/B.E.)"1. LAPACK routines have been ported to the Cell/B.E. in order to make use of its parallel Synergistic Processing Elements (SPEs). The bGS algorithm is based on the LU factorization and solution of a linear system that couples the fluxes for all S_n angles and energy groups on a mesh cell. For every cell of a mesh that has been parallel decomposed on the higher-level Opteron processors, a linear system is transferred to the Cell/B.E. and the parallel LAPACK routines are used to compute a solution, which is then transferred back to the Opteron, where the rest of the computations for the S_n transport problem take place. Compared to standard parallel machines, a hundred-fold speedup of the bGS was observed on the hybrid Roadrunner architecture. Numerical experiments with strong and weak parallel scaling demonstrate the bGS method is viable and compares favorably to full parallel sweeps (FPS) on two-dimensional, unstructured meshes when it is applied to optically thick, multi-material problems. As expected, however, it is not as efficient as FPS in optically thin problems. (author)

  14. Sweep visually evoked potentials and visual findings in children with West syndrome.

    Science.gov (United States)

    de Freitas Dotto, Patrícia; Cavascan, Nívea Nunes; Berezovsky, Adriana; Sacai, Paula Yuri; Rocha, Daniel Martins; Pereira, Josenilson Martins; Salomão, Solange Rios

    2014-03-01

    West syndrome (WS) is a type of early childhood epilepsy characterized by progressive neurological development deterioration that includes vision. To demonstrate the clinical importance of grating visual acuity thresholds (GVA) measurement by sweep visually evoked potentials technique (sweep-VEP) as a reliable tool for evaluation of the visual cortex status in WS children. This is a retrospective study of the best-corrected binocular GVA and ophthalmological features of WS children referred for the Laboratory of Clinical Electrophysiology of Vision of UNIFESP from 1998 to 2012 (Committee on Ethics in Research of UNIFESP n° 0349/08). The GVA deficit was calculated by subtracting binocular GVA score (logMAR units) of each patient from the median values of age norms from our own lab and classified as mild (0.1-0.39 logMAR), moderate (0.40-0.80 logMAR) or severe (>0.81 logMAR). Associated ophthalmological features were also described. Data from 30 WS children (age from 6 to 108 months, median = 14.5 months, mean ± SD = 22.0 ± 22.1 months; 19 male) were analyzed. The majority presented severe GVA deficit (0.15-1.44 logMAR; mean ± SD = 0.82 ± 0.32 logMAR; median = 0.82 logMAR), poor visual behavior, high prevalence of strabismus and great variability in ocular positioning. The GVA deficit did not vary according to gender (P = .8022), WS type (P = .908), birth age (P = .2881), perinatal oxygenation (P = .7692), visual behavior (P = .8789), ocular motility (P = .1821), nystagmus (P = .2868), risk of drug-induced retinopathy (P = .4632) and participation in early visual stimulation therapy (P = .9010). The sweep-VEP technique is a reliable tool to classify visual system impairment in WS children, in agreement with the poor visual behavior exhibited by them. Copyright © 2013 European Paediatric Neurology Society. Published by Elsevier Ltd. All rights reserved.

  15. Sensitive Detection of Organophosphorus Pesticides in Medicinal Plants Using Ultrasound-Assisted Dispersive Liquid-Liquid Microextraction Combined with Sweeping Micellar Electrokinetic Chromatography.

    Science.gov (United States)

    Wei, Jin-Chao; Hu, Ji; Cao, Ji-Liang; Wan, Jian-Bo; He, Cheng-Wei; Hu, Yuan-Jia; Hu, Hao; Li, Peng

    2016-02-03

    A simple, rapid, and sensitive method using ultrasound-assisted dispersive liquid-liquid microextraction (UA-DLLME) combined with sweeping micellar electrokinetic chromatography (sweeping-MEKC) has been developed for the determination of nine organophosphorus pesticides (chlorfenvinphos, parathion, quinalphos, fenitrothion, azinphos-ethyl, parathion-methyl, fensulfothion, methidathion, and paraoxon). The important parameters that affect the UA-DLLME and sweeping efficiency were investigated. Under the optimized conditions, the proposed method provided 779.0-6203.5-fold enrichment of the nine pesticides compared to the normal MEKC method. The limits of detection ranged from 0.002 to 0.008 mg kg(-1). The relative standard deviations of the peak area ranged from 1.2 to 6.5%, indicating the good repeatability of the method. Finally, the developed UA-DLLME-sweeping-MEKC method has been successfully applied to the analysis of the investigated pesticides in several medicinal plants, including Lycium chinense, Dioscorea opposite, Codonopsis pilosula, and Panax ginseng, indicating that this method is suitable for the determination of trace pesticide residues in real samples with complex matrices.

  16. Comparison of measured and simulated friction velocity and threshold friction velocity using SWEEP

    Science.gov (United States)

    The Wind Erosion Prediction System (WEPS) was developed by the USDA Agricultural Research Service as a tool to predict wind erosion and assess the influence of control practices on windblown soil loss. Occasional failure of the WEPS erosion submodel (SWEEP) to simulate erosion in the Columbia Platea...

  17. Comparison of least squares and exponential sine sweep methods for Parallel Hammerstein Models estimation

    Science.gov (United States)

    Rebillat, Marc; Schoukens, Maarten

    2018-05-01

    Linearity is a common assumption for many real-life systems, but in many cases the nonlinear behavior of systems cannot be ignored and must be modeled and estimated. Among the various existing classes of nonlinear models, Parallel Hammerstein Models (PHM) are interesting as they are at the same time easy to interpret as well as to estimate. One way to estimate PHM relies on the fact that the estimation problem is linear in the parameters and thus that classical least squares (LS) estimation algorithms can be used. In that area, this article introduces a regularized LS estimation algorithm inspired on some of the recently developed regularized impulse response estimation techniques. Another mean to estimate PHM consists in using parametric or non-parametric exponential sine sweeps (ESS) based methods. These methods (LS and ESS) are founded on radically different mathematical backgrounds but are expected to tackle the same issue. A methodology is proposed here to compare them with respect to (i) their accuracy, (ii) their computational cost, and (iii) their robustness to noise. Tests are performed on simulated systems for several values of methods respective parameters and of signal to noise ratio. Results show that, for a given set of data points, the ESS method is less demanding in computational resources than the LS method but that it is also less accurate. Furthermore, the LS method needs parameters to be set in advance whereas the ESS method is not subject to conditioning issues and can be fully non-parametric. In summary, for a given set of data points, ESS method can provide a first, automatic, and quick overview of a nonlinear system than can guide more computationally demanding and precise methods, such as the regularized LS one proposed here.

  18. Sweeping-window arc therapy: an implementation of rotational IMRT with automatic beam-weight calculation

    International Nuclear Information System (INIS)

    Cameron, C

    2005-01-01

    Sweeping-window arc therapy (SWAT) is a variation of intensity-modulated radiation therapy (IMRT) with direct aperture optimization (DAO) that is initialized with a leaf sequence of sweeping windows that move back and forth periodically across the target as the gantry rotates. This initial sequence induces modulation in the dose and is assumed to be near enough to a minimum to allow successful optimization, done with simulated annealing, without requiring excessive leaf speeds. Optimal beam weights are calculated analytically, with easy extension to allow for variable beam weights. In this paper SWAT is tested on a phantom model and clinical prostate case. For the phantom, constant and variable beam weights are used. Although further work (in particular, improving the dose model) is required, the results show SWAT to be a feasible approach to generating deliverable dynamic arc treatments that are optimized

  19. Sweeping-window arc therapy: an implementation of rotational IMRT with automatic beam-weight calculation

    Energy Technology Data Exchange (ETDEWEB)

    Cameron, C [Division of Radiation Physics, Department of Radiation Oncology, Stanford Cancer Center, 875 Blake Wilbur Drive, Rm G-233, Stanford, CA 94305-5847 (United States)

    2005-09-21

    Sweeping-window arc therapy (SWAT) is a variation of intensity-modulated radiation therapy (IMRT) with direct aperture optimization (DAO) that is initialized with a leaf sequence of sweeping windows that move back and forth periodically across the target as the gantry rotates. This initial sequence induces modulation in the dose and is assumed to be near enough to a minimum to allow successful optimization, done with simulated annealing, without requiring excessive leaf speeds. Optimal beam weights are calculated analytically, with easy extension to allow for variable beam weights. In this paper SWAT is tested on a phantom model and clinical prostate case. For the phantom, constant and variable beam weights are used. Although further work (in particular, improving the dose model) is required, the results show SWAT to be a feasible approach to generating deliverable dynamic arc treatments that are optimized.

  20. 1 μs broadband frequency sweeping reflectometry for plasma density and fluctuation profile measurements

    Science.gov (United States)

    Clairet, F.; Bottereau, C.; Medvedeva, A.; Molina, D.; Conway, G. D.; Silva, A.; Stroth, U.; ASDEX Upgrade Team; Tore Supra Team; Eurofusion Mst1 Team

    2017-11-01

    Frequency swept reflectometry has reached the symbolic value of 1 μs sweeping time; this performance has been made possible, thanks to an improved control of the ramp voltage driving the frequency source. In parallel, the memory depth of the acquisition system has been upgraded and can provide up to 200 000 signals during a plasma discharge. Additional improvements regarding the trigger delay determination of the acquisition and the voltage ramp linearity required by this ultra-fast technique have been set. While this diagnostic is traditionally dedicated to the plasma electron density profile measurement, such a fast sweeping rate can provide the study of fast plasma events and turbulence with unprecedented time and radial resolution from the edge to the core. Experimental results obtained on ASDEX Upgrade plasmas are presented to demonstrate the performances of the diagnostic.

  1. Laminar oxy-fuel diffusion flame supported by an oxygen-permeable-ion-transport membrane

    KAUST Repository

    Hong, Jongsup

    2013-03-01

    A numerical model with detailed gas-phase chemistry and transport was used to predict homogeneous fuel conversion processes and to capture the important features (e.g., the location, temperature, thickness and structure of a flame) of laminar oxy-fuel diffusion flames stabilized on the sweep side of an oxygen permeable ion transport membrane (ITM). We assume that the membrane surface is not catalytic to hydrocarbon or syngas oxidation. It has been demonstrated that an ITM can be used for hydrocarbon conversion with enhanced reaction selectivity such as oxy-fuel combustion for carbon capture technologies and syngas production. Within an ITM unit, the oxidizer flow rate, i.e., the oxygen permeation flux, is not a pre-determined quantity, since it depends on the oxygen partial pressures on the feed and sweep sides and the membrane temperature. Instead, it is influenced by the oxidation reactions that are also dependent on the oxygen permeation rate, the initial conditions of the sweep gas, i.e., the fuel concentration, flow rate and temperature, and the diluent. In oxy-fuel combustion applications, the sweep side is fuel-diluted with CO2, and the entire unit is preheated to achieve a high oxygen permeation flux. This study focuses on the flame structure under these conditions and specifically on the chemical effect of CO2 dilution. Results show that, when the fuel diluent is CO2, a diffusion flame with a lower temperature and a larger thickness is established in the vicinity of the membrane, in comparison with the case in which N2 is used as a diluent. Enhanced OH-driven reactions and suppressed H radical chemistry result in the formation of products with larger CO and H2O and smaller H2 concentrations. Moreover, radical concentrations are reduced due to the high CO2 fraction in the sweep gas. CO2 dilution reduces CH3 formation and slows down the formation of soot precursors, C2H2 and C2H4. The flame location impacts the species diffusion and heat transfer from the

  2. Wingbeat frequency-sweep and visual stimuli for trapping male Aedes aegypti (Diptera: Culicidae)

    Science.gov (United States)

    Combinations of female wingbeat acoustic cues and visual cues were evaluated to determine their potential for use in male Aedes aegypti (L.) traps in peridomestic environments. A modified Centers for Disease control (CDC) light trap using a 350-500 Hz frequency-sweep broadcast from a speaker as an a...

  3. Optimal block-tridiagonalization of matrices for coherent charge transport

    International Nuclear Information System (INIS)

    Wimmer, Michael; Richter, Klaus

    2009-01-01

    Numerical quantum transport calculations are commonly based on a tight-binding formulation. A wide class of quantum transport algorithms require the tight-binding Hamiltonian to be in the form of a block-tridiagonal matrix. Here, we develop a matrix reordering algorithm based on graph partitioning techniques that yields the optimal block-tridiagonal form for quantum transport. The reordered Hamiltonian can lead to significant performance gains in transport calculations, and allows to apply conventional two-terminal algorithms to arbitrarily complex geometries, including multi-terminal structures. The block-tridiagonalization algorithm can thus be the foundation for a generic quantum transport code, applicable to arbitrary tight-binding systems. We demonstrate the power of this approach by applying the block-tridiagonalization algorithm together with the recursive Green's function algorithm to various examples of mesoscopic transport in two-dimensional electron gases in semiconductors and graphene.

  4. Floyd-A∗ Algorithm Solving the Least-Time Itinerary Planning Problem in Urban Scheduled Public Transport Network

    Directory of Open Access Journals (Sweden)

    Yu Zhang

    2014-01-01

    Full Text Available We consider an ad hoc Floyd-A∗ algorithm to determine the a priori least-time itinerary from an origin to a destination given an initial time in an urban scheduled public transport (USPT network. The network is bimodal (i.e., USPT lines and walking and time dependent. The modified USPT network model results in more reasonable itinerary results. An itinerary is connected through a sequence of time-label arcs. The proposed Floyd-A∗ algorithm is composed of two procedures designated as Itinerary Finder and Cost Estimator. The A∗-based Itinerary Finder determines the time-dependent, least-time itinerary in real time, aided by the heuristic information precomputed by the Floyd-based Cost Estimator, where a strategy is formed to preestimate the time-dependent arc travel time as an associated static lower bound. The Floyd-A∗ algorithm is proven to guarantee optimality in theory and, demonstrated through a real-world example in Shenyang City USPT network to be more efficient than previous procedures. The computational experiments also reveal the time-dependent nature of the least-time itinerary. In the premise that lines run punctually, “just boarding” and “just missing” cases are identified.

  5. Soft sweeps III: the signature of positive selection from recurrent mutation.

    Directory of Open Access Journals (Sweden)

    Pleuni S Pennings

    2006-12-01

    Full Text Available Polymorphism data can be used to identify loci at which a beneficial allele has recently gone to fixation, given that an accurate description of the signature of selection is available. In the classical model that is used, a favored allele derives from a single mutational origin. This ignores the fact that beneficial alleles can enter a population recurrently by mutation during the selective phase. In this study, we present a combination of analytical and simulation results to demonstrate the effect of adaptation from recurrent mutation on summary statistics for polymorphism data from a linked neutral locus. We also analyze the power of standard neutrality tests based on the frequency spectrum or on linkage disequilibrium (LD under this scenario. For recurrent beneficial mutation at biologically realistic rates, we find substantial deviations from the classical pattern of a selective sweep from a single new mutation. Deviations from neutrality in the level of polymorphism and in the frequency spectrum are much less pronounced than in the classical sweep pattern. In contrast, for levels of LD, the signature is even stronger if recurrent beneficial mutation plays a role. We suggest a variant of existing LD tests that increases their power to detect this signature.

  6. On gas sweeping from central regions of galaxies with active nuclei

    International Nuclear Information System (INIS)

    Silich, S.A.; Fomin, P.I.

    1980-01-01

    A mechanism of gas sweeping by shock waves from central regions of plane galaxies with active nuclei which is connected with the angular moment transfer from a stellar-cloud component to a gas one is considered. It is shown that shock waves are capable to form the observable density profile with the maximum at a distance of some kpc from galaxy centre for the time of the order of 10 9 years

  7. Testing block subdivision algorithms on block designs

    Science.gov (United States)

    Wiseman, Natalie; Patterson, Zachary

    2016-01-01

    Integrated land use-transportation models predict future transportation demand taking into account how households and firms arrange themselves partly as a function of the transportation system. Recent integrated models require parcels as inputs and produce household and employment predictions at the parcel scale. Block subdivision algorithms automatically generate parcel patterns within blocks. Evaluating block subdivision algorithms is done by way of generating parcels and comparing them to those in a parcel database. Three block subdivision algorithms are evaluated on how closely they reproduce parcels of different block types found in a parcel database from Montreal, Canada. While the authors who developed each of the algorithms have evaluated them, they have used their own metrics and block types to evaluate their own algorithms. This makes it difficult to compare their strengths and weaknesses. The contribution of this paper is in resolving this difficulty with the aim of finding a better algorithm suited to subdividing each block type. The proposed hypothesis is that given the different approaches that block subdivision algorithms take, it's likely that different algorithms are better adapted to subdividing different block types. To test this, a standardized block type classification is used that consists of mutually exclusive and comprehensive categories. A statistical method is used for finding a better algorithm and the probability it will perform well for a given block type. Results suggest the oriented bounding box algorithm performs better for warped non-uniform sites, as well as gridiron and fragmented uniform sites. It also produces more similar parcel areas and widths. The Generalized Parcel Divider 1 algorithm performs better for gridiron non-uniform sites. The Straight Skeleton algorithm performs better for loop and lollipop networks as well as fragmented non-uniform and warped uniform sites. It also produces more similar parcel shapes and patterns.

  8. Influence of sweeping detonation-wave loading on damage evolution during spallation loading of tantalum in both a planar and curved geometry

    Energy Technology Data Exchange (ETDEWEB)

    Gray, George Thompson III [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Hull, Lawrence Mark [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Livescu, Veronica [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Faulkner, James [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Briggs, Matthew E. [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Meyer, Ross Keith [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Andrews, Heather Lynn [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Hare, Steven John [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Jakulewicz, Micah Shawn [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Shinas, Michael A. [Los Alamos National Lab. (LANL), Los Alamos, NM (United States)

    2015-03-30

    Widespread research over the past five decades has provided a wealth of experimental data and insight concerning the shock hardening, damage evolution, and the spallation response of materials subjected to square-topped shock-wave loading profiles. However, fewer quantitative studies have been conducted on the effect of direct, in-contact, high explosive (HE)-driven Taylor wave (unsupported shocks) loading on the shock hardening, damage evolution, or spallation response of materials. Systematic studies quantifying the effect of sweeping-detonation wave loading are yet sparser. In this study, the damage evolution and spallation response of Ta is shown to be critically dependent on the peak shock stress, the geometry of the sample (flat or curved plate geometry), and the shock obliquity during sweeping-detonation-wave shock loading. Sweepingwave loading in the flat-plate geometry is observed to: a) yield a lower spall strength than previously documented for 1-D supported-shock-wave loading, b) exhibit increased shock hardening as a function of increasing obliquity, and c) lead to an increased incidence of deformation twin formation with increasing shock obliquity. Sweeping-wave loading of a 10 cm radius curved Ta plate is observed to: a) lead to an increase in the shear stress as a function of increasing obliquity, b) display a more developed level of damage evolution, extensive voids and coalescence, and lower spall strength with obliquity in the curved plate than seen in the flat-plate sweeping-detonation wave loading for an equivalent HE loading, and c) no increased propensity for deformation twin formation with increasing obliquity as seen in the flat-plate geometry. The overall observations comparing and contrasting the flat versus curved sweeping-wave spall experiments with 1D loaded spallation behavior suggests a coupled influence of obliquity and geometry on dynamic shock-induced damage evolution and spall strength. Coupled experimental and modeling research

  9. Use of exhaust gas as sweep flow to enhance air separation membrane performance

    Science.gov (United States)

    Dutart, Charles H.; Choi, Cathy Y.

    2003-01-01

    An intake air separation system for an internal combustion engine is provided with purge gas or sweep flow on the permeate side of separation membranes in the air separation device. Exhaust gas from the engine is used as a purge gas flow, to increase oxygen flux in the separation device without increasing the nitrogen flux.

  10. Distinguishing between Selective Sweeps from Standing Variation and from a De Novo Mutation

    Science.gov (United States)

    Peter, Benjamin M.; Huerta-Sanchez, Emilia; Nielsen, Rasmus

    2012-01-01

    An outstanding question in human genetics has been the degree to which adaptation occurs from standing genetic variation or from de novo mutations. Here, we combine several common statistics used to detect selection in an Approximate Bayesian Computation (ABC) framework, with the goal of discriminating between models of selection and providing estimates of the age of selected alleles and the selection coefficients acting on them. We use simulations to assess the power and accuracy of our method and apply it to seven of the strongest sweeps currently known in humans. We identify two genes, ASPM and PSCA, that are most likely affected by selection on standing variation; and we find three genes, ADH1B, LCT, and EDAR, in which the adaptive alleles seem to have swept from a new mutation. We also confirm evidence of selection for one further gene, TRPV6. In one gene, G6PD, neither neutral models nor models of selective sweeps fit the data, presumably because this locus has been subject to balancing selection. PMID:23071458

  11. Distinguishing between selective sweeps from standing variation and from a de novo mutation.

    Directory of Open Access Journals (Sweden)

    Benjamin M Peter

    Full Text Available An outstanding question in human genetics has been the degree to which adaptation occurs from standing genetic variation or from de novo mutations. Here, we combine several common statistics used to detect selection in an Approximate Bayesian Computation (ABC framework, with the goal of discriminating between models of selection and providing estimates of the age of selected alleles and the selection coefficients acting on them. We use simulations to assess the power and accuracy of our method and apply it to seven of the strongest sweeps currently known in humans. We identify two genes, ASPM and PSCA, that are most likely affected by selection on standing variation; and we find three genes, ADH1B, LCT, and EDAR, in which the adaptive alleles seem to have swept from a new mutation. We also confirm evidence of selection for one further gene, TRPV6. In one gene, G6PD, neither neutral models nor models of selective sweeps fit the data, presumably because this locus has been subject to balancing selection.

  12. Field Experience with Sweep Frequency Response Analysis for Power Transformer Diagnosis

    OpenAIRE

    Ambuj Kumar; Sunil Kumar Singh; Shrikant Singh

    2015-01-01

    Sweep frequency response analysis has been turning out a powerful tool for investigation of mechanical as well as electrical integration of transformers. In this paper various aspect of practical application of SFRA has been studied. Open circuit and short circuit measurement were done on different phases of high voltage and low voltage winding. A case study was presented for the transformer of rating 31.5 MVA for various frequency ranges. A clear picture was presented fo...

  13. Optimal Location and Sizing of UPQC in Distribution Networks Using Differential Evolution Algorithm

    Directory of Open Access Journals (Sweden)

    Seyed Abbas Taher

    2012-01-01

    Full Text Available Differential evolution (DE algorithm is used to determine optimal location of unified power quality conditioner (UPQC considering its size in the radial distribution systems. The problem is formulated to find the optimum location of UPQC based on an objective function (OF defined for improving of voltage and current profiles, reducing power loss and minimizing the investment costs considering the OF's weighting factors. Hence, a steady-state model of UPQC is derived to set in forward/backward sweep load flow. Studies are performed on two IEEE 33-bus and 69-bus standard distribution networks. Accuracy was evaluated by reapplying the procedures using both genetic (GA and immune algorithms (IA. Comparative results indicate that DE is capable of offering a nearer global optimal in minimizing the OF and reaching all the desired conditions than GA and IA.

  14. Influence of high-conductivity buffer composition on field-enhanced sample injection coupled to sweeping in CE.

    Science.gov (United States)

    Anres, Philippe; Delaunay, Nathalie; Vial, Jérôme; Thormann, Wolfgang; Gareil, Pierre

    2013-02-01

    The aim of this work was to clarify the mechanism taking place in field-enhanced sample injection coupled to sweeping and micellar EKC (FESI-Sweep-MEKC), with the utilization of two acidic high-conductivity buffers (HCBs), phosphoric acid or sodium phosphate buffer, in view of maximizing sensitivity enhancements. Using cationic model compounds in acidic media, a chemometric approach and simulations with SIMUL5 were implemented. Experimental design first enabled to identify the significant factors and their potential interactions. Simulation demonstrates the formation of moving boundaries during sample injection, which originate at the initial sample/HCB and HCB/buffer discontinuities and gradually change the compositions of HCB and BGE. With sodium phosphate buffer, the HCB conductivity increased during the injection, leading to a more efficient preconcentration by staking (about 1.6 times) than with phosphoric acid alone, for which conductivity decreased during injection. For the same injection time at constant voltage, however, a lower amount of analytes was injected with sodium phosphate buffer than with phosphoric acid. Consequently sensitivity enhancements were lower for the whole FESI-Sweep-MEKC process. This is why, in order to maximize sensitivity enhancements, it is proposed to work with sodium phosphate buffer as HCB and to use constant current during sample injection. © 2013 WILEY-VCH Verlag GmbH & Co. KGaA, Weinheim.

  15. Faster Heavy Ion Transport for HZETRN

    Science.gov (United States)

    Slaba, Tony C.

    2013-01-01

    The deterministic particle transport code HZETRN was developed to enable fast and accurate space radiation transport through materials. As more complex transport solutions are implemented for neutrons, light ions (Z heavy ion (Z > 2) transport algorithm in HZETRN is reviewed, and a simple modification is shown to provide an approximate 5x decrease in execution time for galactic cosmic ray transport. Convergence tests and other comparisons are carried out to verify that numerical accuracy is maintained in the new algorithm.

  16. Improvement of transport-corrected scattering stability and performance using a Jacobi inscatter algorithm for 2D-MOC

    International Nuclear Information System (INIS)

    Stimpson, Shane; Collins, Benjamin; Kochunas, Brendan

    2017-01-01

    The MPACT code, being developed collaboratively by the University of Michigan and Oak Ridge National Laboratory, is the primary deterministic neutron transport solver being deployed within the Virtual Environment for Reactor Applications (VERA) as part of the Consortium for Advanced Simulation of Light Water Reactors (CASL). In many applications of the MPACT code, transport-corrected scattering has proven to be an obstacle in terms of stability, and considerable effort has been made to try to resolve the convergence issues that arise from it. Most of the convergence problems seem related to the transport-corrected cross sections, particularly when used in the 2D method of characteristics (MOC) solver, which is the focus of this work. Here in this paper, the stability and performance of the 2-D MOC solver in MPACT is evaluated for two iteration schemes: Gauss-Seidel and Jacobi. With the Gauss-Seidel approach, as the MOC solver loops over groups, it uses the flux solution from the previous group to construct the inscatter source for the next group. Alternatively, the Jacobi approach uses only the fluxes from the previous outer iteration to determine the inscatter source for each group. Consequently for the Jacobi iteration, the loop over groups can be moved from the outermost loop-as is the case with the Gauss-Seidel sweeper-to the innermost loop, allowing for a substantial increase in efficiency by minimizing the overhead of retrieving segment, region, and surface index information from the ray tracing data. Several test problems are assessed: (1) Babcock & Wilcox 1810 Core I, (2) Dimple S01A-Sq, (3) VERA Progression Problem 5a, and (4) VERA Problem 2a. The Jacobi iteration exhibits better stability than Gauss-Seidel, allowing for converged solutions to be obtained over a much wider range of iteration control parameters. Additionally, the MOC solve time with the Jacobi approach is roughly 2.0-2.5× faster per sweep. While the performance and stability of the Jacobi

  17. A Faster Algorithm for Solving One-Clock Priced Timed Games

    DEFF Research Database (Denmark)

    Hansen, Thomas Dueholm; Ibsen-Jensen, Rasmus; Miltersen, Peter Bro

    2013-01-01

    previously known time bound for solving one-clock priced timed games was 2O(n2+m) , due to Rutkowski. For our improvement, we introduce and study a new algorithm for solving one-clock priced timed games, based on the sweep-line technique from computational geometry and the strategy iteration paradigm from......One-clock priced timed games is a class of two-player, zero-sum, continuous-time games that was defined and thoroughly studied in previous works. We show that one-clock priced timed games can be solved in time m 12 n n O(1), where n is the number of states and m is the number of actions. The best...

  18. A Faster Algorithm for Solving One-Clock Priced Timed Games

    DEFF Research Database (Denmark)

    Hansen, Thomas Dueholm; Ibsen-Jensen, Rasmus; Miltersen, Peter Bro

    2012-01-01

    previously known time bound for solving one-clock priced timed games was 2^(O(n^2+m)), due to Rutkowski. For our improvement, we introduce and study a new algorithm for solving one-clock priced timed games, based on the sweep-line technique from computational geometry and the strategy iteration paradigm from......One-clock priced timed games is a class of two-player, zero-sum, continuous-time games that was defined and thoroughly studied in previous works. We show that one-clock priced timed games can be solved in time m 12^n n^(O(1)), where n is the number of states and m is the number of actions. The best...

  19. Signatures of positive selection: from selective sweeps at individual loci to subtle allele frequency changes in polygenic adaptation.

    Science.gov (United States)

    Stephan, Wolfgang

    2016-01-01

    In the past 15 years, numerous methods have been developed to detect selective sweeps underlying adaptations. These methods are based on relatively simple population genetic models, including one or two loci at which positive directional selection occurs, and one or two marker loci at which the impact of selection on linked neutral variation is quantified. Information about the phenotype under selection is not included in these models (except for fitness). In contrast, in the quantitative genetic models of adaptation, selection acts on one or more phenotypic traits, such that a genotype-phenotype map is required to bridge the gap to population genetics theory. Here I describe the range of population genetic models from selective sweeps in a panmictic population of constant size to evolutionary traffic when simultaneous sweeps at multiple loci interfere, and I also consider the case of polygenic selection characterized by subtle allele frequency shifts at many loci. Furthermore, I present an overview of the statistical tests that have been proposed based on these population genetics models to detect evidence for positive selection in the genome. © 2015 John Wiley & Sons Ltd.

  20. Hybrid subgroup decomposition method for solving fine-group eigenvalue transport problems

    International Nuclear Information System (INIS)

    Yasseri, Saam; Rahnema, Farzad

    2014-01-01

    Highlights: • An acceleration technique for solving fine-group eigenvalue transport problems. • Coarse-group quasi transport theory to solve coarse-group eigenvalue transport problems. • Consistent and inconsistent formulations for coarse-group quasi transport theory. • Computational efficiency amplified by a factor of 2 using hybrid SGD for 1D BWR problem. - Abstract: In this paper, a new hybrid method for solving fine-group eigenvalue transport problems is developed. This method extends the subgroup decomposition method to efficiently couple a new coarse-group quasi transport theory with a set of fixed-source transport decomposition sweeps to obtain the fine-group transport solution. The advantages of the quasi transport theory are its high accuracy, straight-forward implementation and numerical stability. The hybrid method is analyzed for a 1D benchmark problem characteristic of boiling water reactors (BWR). It is shown that the method reproduces the fine-group transport solution with high accuracy while increasing the computational efficiency up to 12 times compared to direct fine-group transport calculations

  1. Efficient implementation of the transportation algorithm for the ...

    African Journals Online (AJOL)

    This paper analyses the transportation problem of the NBC, amongst its distribution pattern of the South-South Zone of Nigeria. The Tora software was used to analyze the data. We solved the transportation planning problems sequentially each by the transportation model for the available data from NBC for the 2012 ...

  2. Single feature polymorphism (SFP-based selective sweep identification and association mapping of growth-related metabolic traits in Arabidopsis thaliana

    Directory of Open Access Journals (Sweden)

    Stitt Mark

    2010-03-01

    Full Text Available Abstract Background Natural accessions of Arabidopsis thaliana are characterized by a high level of phenotypic variation that can be used to investigate the extent and mode of selection on the primary metabolic traits. A collection of 54 A. thaliana natural accession-derived lines were subjected to deep genotyping through Single Feature Polymorphism (SFP detection via genomic DNA hybridization to Arabidopsis Tiling 1.0 Arrays for the detection of selective sweeps, and identification of associations between sweep regions and growth-related metabolic traits. Results A total of 1,072,557 high-quality SFPs were detected and indications for 3,943 deletions and 1,007 duplications were obtained. A significantly lower than expected SFP frequency was observed in protein-, rRNA-, and tRNA-coding regions and in non-repetitive intergenic regions, while pseudogenes, transposons, and non-coding RNA genes are enriched with SFPs. Gene families involved in plant defence or in signalling were identified as highly polymorphic, while several other families including transcription factors are depleted of SFPs. 198 significant associations between metabolic genes and 9 metabolic and growth-related phenotypic traits were detected with annotation hinting at the nature of the relationship. Five significant selective sweep regions were also detected of which one associated significantly with a metabolic trait. Conclusions We generated a high density polymorphism map for 54 A. thaliana accessions that highlights the variability of resistance genes across geographic ranges and used it to identify selective sweeps and associations between metabolic genes and metabolic phenotypes. Several associations show a clear biological relationship, while many remain requiring further investigation.

  3. Performance of a fine-grained parallel model for multi-group nodal-transport calculations in three-dimensional pin-by-pin reactor geometry

    International Nuclear Information System (INIS)

    Masahiro, Tatsumi; Akio, Yamamoto

    2003-01-01

    A production code SCOPE2 was developed based on the fine-grained parallel algorithm by the red/black iterative method targeting parallel computing environments such as a PC-cluster. It can perform a depletion calculation in a few hours using a PC-cluster with the model based on a 9-group nodal-SP3 transport method in 3-dimensional pin-by-pin geometry for in-core fuel management of commercial PWRs. The present algorithm guarantees the identical convergence process as that in serial execution, which is very important from the viewpoint of quality management. The fine-mesh geometry is constructed by hierarchical decomposition with introduction of intermediate management layer as a block that is a quarter piece of a fuel assembly in radial direction. A combination of a mesh division scheme forcing even meshes on each edge and a latency-hidden communication algorithm provided simplicity and efficiency to message passing to enhance parallel performance. Inter-processor communication and parallel I/O access were realized using the MPI functions. Parallel performance was measured for depletion calculations by the 9-group nodal-SP3 transport method in 3-dimensional pin-by-pin geometry with 340 x 340 x 26 meshes for full core geometry and 170 x 170 x 26 for quarter core geometry. A PC cluster that consists of 24 Pentium-4 processors connected by the Fast Ethernet was used for the performance measurement. Calculations in full core geometry gave better speedups compared to those in quarter core geometry because of larger granularity. Fine-mesh sweep and feedback calculation parts gave almost perfect scalability since granularity is large enough, while 1-group coarse-mesh diffusion acceleration gave only around 80%. The speedup and parallel efficiency for total computation time were 22.6 and 94%, respectively, for the calculation in full core geometry with 24 processors. (authors)

  4. Evaluation of the new electron-transport algorithm in MCNP6.1 for the simulation of dose point kernel in water

    Science.gov (United States)

    Antoni, Rodolphe; Bourgois, Laurent

    2017-12-01

    In this work, the calculation of specific dose distribution in water is evaluated in MCNP6.1 with the regular condensed history algorithm the "detailed electron energy-loss straggling logic" and the new electrons transport algorithm proposed the "single event algorithm". Dose Point Kernel (DPK) is calculated with monoenergetic electrons of 50, 100, 500, 1000 and 3000 keV for different scoring cells dimensions. A comparison between MCNP6 results and well-validated codes for electron-dosimetry, i.e., EGSnrc or Penelope, is performed. When the detailed electron energy-loss straggling logic is used with default setting (down to the cut-off energy 1 keV), we infer that the depth of the dose peak increases with decreasing thickness of the scoring cell, largely due to combined step-size and boundary crossing artifacts. This finding is less prominent for 500 keV, 1 MeV and 3 MeV dose profile. With an appropriate number of sub-steps (ESTEP value in MCNP6), the dose-peak shift is almost complete absent to 50 keV and 100 keV electrons. However, the dose-peak is more prominent compared to EGSnrc and the absorbed dose tends to be underestimated at greater depths, meaning that boundaries crossing artifact are still occurring while step-size artifacts are greatly reduced. When the single-event mode is used for the whole transport, we observe the good agreement of reference and calculated profile for 50 and 100 keV electrons. Remaining artifacts are fully vanished, showing a possible transport treatment for energies less than a hundred of keV and accordance with reference for whatever scoring cell dimension, even if the single event method initially intended to support electron transport at energies below 1 keV. Conversely, results for 500 keV, 1 MeV and 3 MeV undergo a dramatic discrepancy with reference curves. These poor results and so the current unreliability of the method is for a part due to inappropriate elastic cross section treatment from the ENDF/B-VI.8 library in those

  5. An improvement of the fast uncovering community algorithm

    International Nuclear Information System (INIS)

    Wang Li; Wang Jiang; Shen Hua-Wei; Cheng Xue-Qi

    2013-01-01

    Community detection methods have been used in computer, sociology, physics, biology, and brain information science areas. Many methods are based on the optimization of modularity. The algorithm proposed by Blondel et al. (Blondel V D, Guillaume J L, Lambiotte R and Lefebvre E 2008 J. Stat. Mech. 10 10008) is one of the most widely used methods because of its good performance, especially in the big data era. In this paper we make some improvements to this algorithm in correctness and performance. By tests we see that different node orders bring different performances and different community structures. We find some node swings in different communities that influence the performance. So we design some strategies on the sweeping order of node to reduce the computing cost made by repetition swing. We introduce a new concept of overlapping degree (OV) that shows the strength of connection between nodes. Three improvement strategies are proposed that are based on constant OV, adaptive OV, and adaptive weighted OV, respectively. Experiments on synthetic datasets and real datasets are made, showing that our improved strategies can improve the performance and correctness. (interdisciplinary physics and related areas of science and technology)

  6. Objective quantification of the tinnitus decompensation by synchronization measures of auditory evoked single sweeps.

    Science.gov (United States)

    Strauss, Daniel J; Delb, Wolfgang; D'Amelio, Roberto; Low, Yin Fen; Falkai, Peter

    2008-02-01

    Large-scale neural correlates of the tinnitus decompensation might be used for an objective evaluation of therapies and neurofeedback based therapeutic approaches. In this study, we try to identify large-scale neural correlates of the tinnitus decompensation using wavelet phase stability criteria of single sweep sequences of late auditory evoked potentials as synchronization stability measure. The extracted measure provided an objective quantification of the tinnitus decompensation and allowed for a reliable discrimination between a group of compensated and decompensated tinnitus patients. We provide an interpretation for our results by a neural model of top-down projections based on the Jastreboff tinnitus model combined with the adaptive resonance theory which has not been applied to model tinnitus so far. Using this model, our stability measure of evoked potentials can be linked to the focus of attention on the tinnitus signal. It is concluded that the wavelet phase stability of late auditory evoked potential single sweeps might be used as objective tinnitus decompensation measure and can be interpreted in the framework of the Jastreboff tinnitus model and adaptive resonance theory.

  7. Planetesimal formation by sweep-up coagulation

    Science.gov (United States)

    Windmark, Fredrik; Birnstiel, Til; Ormel, Chris W.; Dullemond, Cornelis P.

    2013-07-01

    The formation of planetesimals is often accredited to collisional sticking of dust grains in the protoplanetary disk. The exact process is however unknown, as collisions between larger aggregates tend to lead to fragmentation or bouncing rather than sticking. These growth barriers tend to halt the dust growth already at millimeters or centimeters in size, which is far below the kilometer-sizes that are needed for gravity to aid in the accretion. To study how far dust coagulation can proceed, we have developed a new collision model based on the latest laboratory experiments, and have used it together with a dust-size evolution code capable of resolving all grain interactions in the protoplanetary disk. We find that for the general dust population, bouncing and fragmenting collisions prevent the growth above millimeter-sizes. However, a small number of lucky particles can grow larger than the rest by only interacting at low, sticky velocities. As they grow, they become increasingly resilient to fragmentation caused by the small grains. In this way, two populations are formed: One which remains small due to the collisional barriers, and one that continues to grow by sweeping up the smaller grains around them.

  8. Optimal transport on supply-demand networks.

    Science.gov (United States)

    Chen, Yu-Han; Wang, Bing-Hong; Zhao, Li-Chao; Zhou, Changsong; Zhou, Tao

    2010-06-01

    In the literature, transport networks are usually treated as homogeneous networks, that is, every node has the same function, simultaneously providing and requiring resources. However, some real networks, such as power grids and supply chain networks, show a far different scenario in which nodes are classified into two categories: supply nodes provide some kinds of services, while demand nodes require them. In this paper, we propose a general transport model for these supply-demand networks, associated with a criterion to quantify their transport capacities. In a supply-demand network with heterogeneous degree distribution, its transport capacity strongly depends on the locations of supply nodes. We therefore design a simulated annealing algorithm to find the near optimal configuration of supply nodes, which remarkably enhances the transport capacity compared with a random configuration and outperforms the degree target algorithm, the betweenness target algorithm, and the greedy method. This work provides a start point for systematically analyzing and optimizing transport dynamics on supply-demand networks.

  9. Topography of sound level representation in the FM sweep selective region of the pallid bat auditory cortex.

    Science.gov (United States)

    Measor, Kevin; Yarrow, Stuart; Razak, Khaleel A

    2018-05-26

    Sound level processing is a fundamental function of the auditory system. To determine how the cortex represents sound level, it is important to quantify how changes in level alter the spatiotemporal structure of cortical ensemble activity. This is particularly true for echolocating bats that have control over, and often rapidly adjust, call level to actively change echo level. To understand how cortical activity may change with sound level, here we mapped response rate and latency changes with sound level in the auditory cortex of the pallid bat. The pallid bat uses a 60-30 kHz downward frequency modulated (FM) sweep for echolocation. Neurons tuned to frequencies between 30 and 70 kHz in the auditory cortex are selective for the properties of FM sweeps used in echolocation forming the FM sweep selective region (FMSR). The FMSR is strongly selective for sound level between 30 and 50 dB SPL. Here we mapped the topography of level selectivity in the FMSR using downward FM sweeps and show that neurons with more monotonic rate level functions are located in caudomedial regions of the FMSR overlapping with high frequency (50-60 kHz) neurons. Non-monotonic neurons dominate the FMSR, and are distributed across the entire region, but there is no evidence for amplitopy. We also examined how first spike latency of FMSR neurons change with sound level. The majority of FMSR neurons exhibit paradoxical latency shift wherein the latency increases with sound level. Moreover, neurons with paradoxical latency shifts are more strongly level selective and are tuned to lower sound level than neurons in which latencies decrease with level. These data indicate a clustered arrangement of neurons according to monotonicity, with no strong evidence for finer scale topography, in the FMSR. The latency analysis suggests mechanisms for strong level selectivity that is based on relative timing of excitatory and inhibitory inputs. Taken together, these data suggest how the spatiotemporal

  10. Thermal transients due to sweeping of the separatrix on the monoblock divertor concept for ITER

    International Nuclear Information System (INIS)

    Renda, V.; Papa, L.; Soria, A.

    1991-01-01

    The ITER divertor plate considered in the present study is the monoblock design option, consisting of an armour of CFC-SEP-Carb graphite tiles, crossed by the tubes of the water cooling system made in Mo-Re alloy. Preliminary steady-state calculations for a peak flux of 15 MW/m 2 showed that the allowable thickness to limit the maximum temperature to 1273 K (1000degC) is about 5 mm. This small value reduces the lifetime of the plate, due to the expected erosion rate, to an unacceptable value from the engineering standpoint. A sweeping of the separatrix has been proposed to reduce the erosion of the protective armour and to lessen the thermomechanical effects of the localized peak surface heat flux. A rotation of the null points of the separatrix of 30 mm radius with a frequency of 0.3 Hz for a surface heat flux of 15 MW/m 2 was assumed as nominal working condition. Several scenarios were considered as off-normal conditions: the loss of sweeping accident, the change in frequency from 0.3 to 0.1 Hz and the change of the peak of the surface heat flux from 15 to 30 MW/m 2 . The results related to the nominal condition show that a 16 mm thick armour could be allowed; this value should ensure an acceptable lifetime for the divertor plate. The loss of sweeping accident leads the surface temperature to reach about 2273 K in few seconds; the change in frequency raises the maximum temperature of 423 K, but its range doubles; the change in peak flux leads to a maximum temperature of about 2373 K. (author)

  11. An algorithm for the solution of dynamic linear programs

    Science.gov (United States)

    Psiaki, Mark L.

    1989-01-01

    The algorithm's objective is to efficiently solve Dynamic Linear Programs (DLP) by taking advantage of their special staircase structure. This algorithm constitutes a stepping stone to an improved algorithm for solving Dynamic Quadratic Programs, which, in turn, would make the nonlinear programming method of Successive Quadratic Programs more practical for solving trajectory optimization problems. The ultimate goal is to being trajectory optimization solution speeds into the realm of real-time control. The algorithm exploits the staircase nature of the large constraint matrix of the equality-constrained DLPs encountered when solving inequality-constrained DLPs by an active set approach. A numerically-stable, staircase QL factorization of the staircase constraint matrix is carried out starting from its last rows and columns. The resulting recursion is like the time-varying Riccati equation from multi-stage LQR theory. The resulting factorization increases the efficiency of all of the typical LP solution operations over that of a dense matrix LP code. At the same time numerical stability is ensured. The algorithm also takes advantage of dynamic programming ideas about the cost-to-go by relaxing active pseudo constraints in a backwards sweeping process. This further decreases the cost per update of the LP rank-1 updating procedure, although it may result in more changes of the active set that if pseudo constraints were relaxed in a non-stagewise fashion. The usual stability of closed-loop Linear/Quadratic optimally-controlled systems, if it carries over to strictly linear cost functions, implies that the saving due to reduced factor update effort may outweigh the cost of an increased number of updates. An aerospace example is presented in which a ground-to-ground rocket's distance is maximized. This example demonstrates the applicability of this class of algorithms to aerospace guidance. It also sheds light on the efficacy of the proposed pseudo constraint relaxation

  12. Private selective sweeps identified from next-generation pool-sequencing reveal convergent pathways under selection in two inbred Schistosoma mansoni strains.

    Directory of Open Access Journals (Sweden)

    Julie A J Clément

    Full Text Available BACKGROUND: The trematode flatworms of the genus Schistosoma, the causative agents of schistosomiasis, are among the most prevalent parasites in humans, affecting more than 200 million people worldwide. In this study, we focused on two well-characterized strains of S. mansoni, to explore signatures of selection. Both strains are highly inbred and exhibit differences in life history traits, in particular in their compatibility with the intermediate host Biomphalaria glabrata. METHODOLOGY/PRINCIPAL FINDINGS: We performed high throughput sequencing of DNA from pools of individuals of each strain using Illumina technology and identified single nucleotide polymorphisms (SNP and copy number variations (CNV. In total, 708,898 SNPs were identified and roughly 2,000 CNVs. The SNPs revealed low nucleotide diversity (π = 2 × 10(-4 within each strain and a high differentiation level (Fst = 0.73 between them. Based on a recently developed in-silico approach, we further detected 12 and 19 private (i.e. specific non-overlapping selective sweeps among the 121 and 151 sweeps found in total for each strain. CONCLUSIONS/SIGNIFICANCE: Functional annotation of transcripts lying in the private selective sweeps revealed specific selection for functions related to parasitic interaction (e.g. cell-cell adhesion or redox reactions. Despite high differentiation between strains, we identified evolutionary convergence of genes related to proteolysis, known as a key virulence factor and a potential target of drug and vaccine development. Our data show that pool-sequencing can be used for the detection of selective sweeps in parasite populations and enables one to identify biological functions under selection.

  13. Reducing Side-Sweep Accidents with Vehicle-to-Vehicle Communication

    Directory of Open Access Journals (Sweden)

    Gamini Bulumulle

    2016-12-01

    Full Text Available Side-sweep accidents are one of the major causes of loss of life and property damage on highways. This type of accident is caused by a driver initiating a lane change while another vehicle is blocking the road in the target lane. In this article, we are trying to quantify the degree to which different implementations of vehicle-to-vehicle (V2V communication could reduce the occurrence of such accidents. We present the design of a simulator that takes into account common sources of lack of driver awareness such as blind-spots and lack of attention. Then, we study the impact of both traditional, non-technological communication means such as turning signals as well as unidirectional and bidirectional V2V communications.

  14. Multi-Stage Transportation Problem With Capacity Limit

    Directory of Open Access Journals (Sweden)

    I. Brezina

    2010-06-01

    Full Text Available The classical transportation problem can be applied in a more general way in practice. Related problems as Multi-commodity transportation problem, Transportation problems with different kind of vehicles, Multi-stage transportation problems, Transportation problem with capacity limit is an extension of the classical transportation problem considering the additional special condition. For solving such problems many optimization techniques (dynamic programming, linear programming, special algorithms for transportation problem etc. and heuristics approaches (e.g. evolutionary techniques were developed. This article considers Multi-stage transportation problem with capacity limit that reflects limits of transported materials (commodity quantity. Discussed issues are: theoretical base, problem formulation as way as new proposed algorithm for that problem.

  15. Local transport method for hybrid diffusion-transport calculations in 2-D cylindrical (R, THETA) geometry

    International Nuclear Information System (INIS)

    Zhang, Dingkang; Rahnema, Farzad; Ougouag, Abderrfi M.

    2011-01-01

    A response-based local transport method has been developed in 2-D (r, θ) geometry for coupling to any coarse-mesh (nodal) diffusion method/code. Monte Carlo method is first used to generate a (pre-computed) the response function library for each unique coarse mesh in the transport domain (e.g., the outer reflector region of the Pebble Bed Reactor). The scalar flux and net current at the diffusion/transport interface provided by the diffusion method are used as an incoming surface source to the transport domain. A deterministic iterative sweeping method together with the response function library is utilized to compute the local transport solution within all transport coarse meshes. After the partial angular currents crossing the coarse mesh surfaces are converged, albedo coefficients are computed as boundary conditions for the diffusion methods. The iteration on the albedo boundary condition (for the diffusion method via transport) and the incoming angular flux boundary condition (for the transport via diffusion) is continued until convergence is achieved. The method was tested for in a simplified 2-D (r, θ) pebble bed reactor problem consisting of an inner reflector, an annular fuel region and a controlled outer reflector. The comparisons have shown that the results of the response-function-based transport method agree very well with a direct MCNP whole core solution. The agreement in coarse mesh averaged flux was found to be excellent: relative difference of about 0.18% and a maximum difference of about 0.55%. Note that the MCNP uncertainty was less than 0.1%. (author)

  16. Spin-Label CW Microwave Power Saturation and Rapid Passage with Triangular Non-Adiabatic Rapid Sweep (NARS) and Adiabatic Rapid Passage (ARP) EPR Spectroscopy

    Science.gov (United States)

    Kittell, Aaron W.; Hyde, James S.

    2015-01-01

    Non-adiabatic rapid passage (NARS) electron paramagnetic resonance (EPR) spectroscopy was introduced by Kittell, A.W., Camenisch, T.G., Ratke, J.J. Sidabras, J.W., Hyde, J.S., 2011 as a general purpose technique to collect the pure absorption response. The technique has been used to improve sensitivity relative to sinusoidal magnetic field modulation, increase the range of inter-spin distances that can be measured under near physiological conditions, and enhance spectral resolution in copper (II) spectra. In the present work, the method is extended to CW microwave power saturation of spin-labeled T4 Lysozyme (T4L). As in the cited papers, rapid triangular sweep of the polarizing magnetic field was superimposed on slow sweep across the spectrum. Adiabatic rapid passage (ARP) effects were encountered in samples undergoing very slow rotational diffusion as the triangular magnetic field sweep rate was increased. The paper reports results of variation of experimental parameters at the interface of adiabatic and non-adiabatic rapid sweep conditions. Comparison of the forward (up) and reverse (down) triangular sweeps is shown to be a good indicator of the presence of rapid passage effects. Spectral turning points can be distinguished from spectral regions between turning points in two ways: differential microwave power saturation and differential passage effects. Oxygen accessibility data are shown under NARS conditions that appear similar to conventional field modulation data. However, the sensitivity is much higher, permitting, in principle, experiments at substantially lower protein concentrations. Spectral displays were obtained that appear sensitive to rotational diffusion in the range of rotational correlation times of 10−3 to 10−7 s in a manner that is analogous to saturation transfer spectroscopy. PMID:25917132

  17. New Parallel Algorithms for Landscape Evolution Model

    Science.gov (United States)

    Jin, Y.; Zhang, H.; Shi, Y.

    2017-12-01

    Most landscape evolution models (LEM) developed in the last two decades solve the diffusion equation to simulate the transportation of surface sediments. This numerical approach is difficult to parallelize due to the computation of drainage area for each node, which needs huge amount of communication if run in parallel. In order to overcome this difficulty, we developed two parallel algorithms for LEM with a stream net. One algorithm handles the partition of grid with traditional methods and applies an efficient global reduction algorithm to do the computation of drainage areas and transport rates for the stream net; the other algorithm is based on a new partition algorithm, which partitions the nodes in catchments between processes first, and then partitions the cells according to the partition of nodes. Both methods focus on decreasing communication between processes and take the advantage of massive computing techniques, and numerical experiments show that they are both adequate to handle large scale problems with millions of cells. We implemented the two algorithms in our program based on the widely used finite element library deal.II, so that it can be easily coupled with ASPECT.

  18. Synthetic acceleration methods for linear transport problems with highly anisotropic scattering

    International Nuclear Information System (INIS)

    Khattab, K.M.

    1989-01-01

    One of the iterative methods which is used to solve the discretized transport equation is called the Source Iteration Method (SI). The SI method converges very slowly for problems with optically thick regions and scattering ratios (σ s /σ t ) near unity. The Diffusion-Synthetic Acceleration method (DSA) is one of the methods which has been devised to improve the convergence rate of the SI method. The DSA method is a good tool to accelerate the SI method, if the particle which is being dealt with is a neutron. This is because the scattering process for neutrons is not severely anisotropic. However, if the particle is a charged particle (electron), DSA becomes ineffective as an acceleration device because here the scattering process is severely anisotropic. To improve the DSA algorithm for electron transport, the author approaches the problem in two different ways in this thesis. He develops the first approach by accelerating more angular moments (φ 0 , φ 1 , φ 2 , φ 3 ,...) than is done in DSA; he calls this approach the Modified P N Synthetic Acceleration (MPSA) method. In the second approach he modifies the definition of the transport sweep, using the physics of the scattering; he calls this approach the Modified Diffusion Synthetic Acceleration (MDSA) method. In general, he has developed, analyzed, and implemented the MPSA and MDSA methods in this thesis and has shown that for a high order quadrature set and mesh widths about 1.0 cm, they are each about 34 times faster (clock time) than the DSA method. Also, he has found that the MDSA spectral radius decreases as the mesh size increases. This makes the MDSA method a better choice for large spatial meshes

  19. Linear sweep polarographic determination of nucleic acids using acridine orange as a bioprobe

    Directory of Open Access Journals (Sweden)

    WEI SUN

    2007-11-01

    Full Text Available The interaction of acridine orange (AO with double-stranded (ds DNA in aqueous solution was investigated by linear sweep polarography (LSP on a dropping mercury working electrode (DME. In pH 2.5 Britton–Robinson (B–R buffer solution, AO had a sensitive linear sweep polarographic reductive peak at –0.89 V (vs. SCE, which could be greatly inhibited by the addition of dsDNA, with a positive shift of the peak potential. Based on the decrease of the reductive peak current, a new quantitative electrochemical determination method for dsDNA was developed with a linear range of 2.0−20.0 mg l-1 and the linear regression equation: ΔIp” (nA = 111.90 C (mg l-1+125.32 (n = 9, γ = 0.997. The influences of commonly co-existing substances, such as metal ions, amino acid, etc., on the determination were also investigated. The method is sensitive, rapid and simple with good selectivity. The new proposed method was further applied to the detection of RNA and three synthetic samples containing dsDNA with satisfactory results. The binding number and the equilibrium constant between dsDNA and AO were calculated by an electrochemical method.

  20. Genome-wide Selective Sweeps in Natural Bacterial Populations Revealed by Time-series Metagenomics

    Energy Technology Data Exchange (ETDEWEB)

    Chan, Leong-Keat; Bendall, Matthew L.; Malfatti, Stephanie; Schwientek, Patrick; Tremblay, Julien; Schackwitz, Wendy; Martin, Joel; Pati, Amrita; Bushnell, Brian; Foster, Brian; Kang, Dongwan; Tringe, Susannah G.; Bertilsson, Stefan; Moran, Mary Ann; Shade, Ashley; Newton, Ryan J.; Stevens, Sarah; McMcahon, Katherine D.; Mamlstrom, Rex R.

    2014-05-12

    Multiple evolutionary models have been proposed to explain the formation of genetically and ecologically distinct bacterial groups. Time-series metagenomics enables direct observation of evolutionary processes in natural populations, and if applied over a sufficiently long time frame, this approach could capture events such as gene-specific or genome-wide selective sweeps. Direct observations of either process could help resolve how distinct groups form in natural microbial assemblages. Here, from a three-year metagenomic study of a freshwater lake, we explore changes in single nucleotide polymorphism (SNP) frequencies and patterns of gene gain and loss in populations of Chlorobiaceae and Methylophilaceae. SNP analyses revealed substantial genetic heterogeneity within these populations, although the degree of heterogeneity varied considerably among closely related, co-occurring Methylophilaceae populations. SNP allele frequencies, as well as the relative abundance of certain genes, changed dramatically over time in each population. Interestingly, SNP diversity was purged at nearly every genome position in one of the Chlorobiaceae populations over the course of three years, while at the same time multiple genes either swept through or were swept from this population. These patterns were consistent with a genome-wide selective sweep, a process predicted by the ecotype model? of diversification, but not previously observed in natural populations.

  1. Genome-wide Selective Sweeps in Natural Bacterial Populations Revealed by Time-series Metagenomics

    Energy Technology Data Exchange (ETDEWEB)

    Chan, Leong-Keat; Bendall, Matthew L.; Malfatti, Stephanie; Schwientek, Patrick; Tremblay, Julien; Schackwitz, Wendy; Martin, Joel; Pati, Amrita; Bushnell, Brian; Foster, Brian; Kang, Dongwan; Tringe, Susannah G.; Bertilsson, Stefan; Moran, Mary Ann; Shade, Ashley; Newton, Ryan J.; Stevens, Sarah; McMahon, Katherine D.; Malmstrom, Rex R.

    2014-06-18

    Multiple evolutionary models have been proposed to explain the formation of genetically and ecologically distinct bacterial groups. Time-series metagenomics enables direct observation of evolutionary processes in natural populations, and if applied over a sufficiently long time frame, this approach could capture events such as gene-specific or genome-wide selective sweeps. Direct observations of either process could help resolve how distinct groups form in natural microbial assemblages. Here, from a three-year metagenomic study of a freshwater lake, we explore changes in single nucleotide polymorphism (SNP) frequencies and patterns of gene gain and loss in populations of Chlorobiaceae and Methylophilaceae. SNP analyses revealed substantial genetic heterogeneity within these populations, although the degree of heterogeneity varied considerably among closely related, co-occurring Methylophilaceae populations. SNP allele frequencies, as well as the relative abundance of certain genes, changed dramatically over time in each population. Interestingly, SNP diversity was purged at nearly every genome position in one of the Chlorobiaceae populations over the course of three years, while at the same time multiple genes either swept through or were swept from this population. These patterns were consistent with a genome-wide selective sweep, a process predicted by the ‘ecotype model’ of diversification, but not previously observed in natural populations.

  2. Optimal calculational schemes for solving multigroup photon transport problem

    International Nuclear Information System (INIS)

    Dubinin, A.A.; Kurachenko, Yu.A.

    1987-01-01

    A scheme of complex algorithm for solving multigroup equation of radiation transport is suggested. The algorithm is based on using the method of successive collisions, the method of forward scattering and the spherical harmonics method, and is realized in the FORAP program (FORTRAN, BESM-6 computer). As an example the results of calculating reactor photon transport in water are presented. The considered algorithm being modified may be used for solving neutron transport problems

  3. Efficient sampling algorithms for Monte Carlo based treatment planning

    International Nuclear Information System (INIS)

    DeMarco, J.J.; Solberg, T.D.; Chetty, I.; Smathers, J.B.

    1998-01-01

    Efficient sampling algorithms are necessary for producing a fast Monte Carlo based treatment planning code. This study evaluates several aspects of a photon-based tracking scheme and the effect of optimal sampling algorithms on the efficiency of the code. Four areas were tested: pseudo-random number generation, generalized sampling of a discrete distribution, sampling from the exponential distribution, and delta scattering as applied to photon transport through a heterogeneous simulation geometry. Generalized sampling of a discrete distribution using the cutpoint method can produce speedup gains of one order of magnitude versus conventional sequential sampling. Photon transport modifications based upon the delta scattering method were implemented and compared with a conventional boundary and collision checking algorithm. The delta scattering algorithm is faster by a factor of six versus the conventional algorithm for a boundary size of 5 mm within a heterogeneous geometry. A comparison of portable pseudo-random number algorithms and exponential sampling techniques is also discussed

  4. Cross-polarization phenomena in the NMR of fast spinning solids subject to adiabatic sweeps

    Energy Technology Data Exchange (ETDEWEB)

    Wi, Sungsool, E-mail: sungsool@magnet.fsu.edu, E-mail: lucio.frydman@weizmann.ac.il; Gan, Zhehong [National High Magnetic Field Laboratory, Tallahassee, Florida 32304 (United States); Schurko, Robert [Department of Chemistry and Biochemistry, University of Windsor, 401 Sunset Avenue, Windsor N9B 3P4, Ontario (Canada); Frydman, Lucio, E-mail: sungsool@magnet.fsu.edu, E-mail: lucio.frydman@weizmann.ac.il [National High Magnetic Field Laboratory, Tallahassee, Florida 32304 (United States); Department of Chemical Physics, Weizmann Institute of Sciences, 76100 Rehovot (Israel)

    2015-02-14

    Cross-polarization magic-angle spinning (CPMAS) experiments employing frequency-swept pulses are explored within the context of obtaining broadband signal enhancements for rare spin S = 1/2 nuclei at very high magnetic fields. These experiments employ adiabatic inversion pulses on the S-channel ({sup 13}C) to cover a wide frequency offset range, while simultaneously applying conventional spin-locking pulse on the I-channel ({sup 1}H). Conditions are explored where the adiabatic frequency sweep width, Δν, is changed from selectively irradiating a single magic-angle-spinning (MAS) spinning centerband or sideband, to sweeping over multiple sidebands. A number of new physical features emerge upon assessing the swept-CP method under these conditions, including multiple zero- and double-quantum CP transfers happening in unison with MAS-driven rotary resonance phenomena. These were examined using an average Hamiltonian theory specifically designed to tackle these experiments, with extensive numerical simulations, and with experiments on model compounds. Ultrawide CP profiles spanning frequency ranges of nearly 6⋅γB{sub 1}{sup s} were predicted and observed utilizing this new approach. Potential extensions and applications of this extremely broadband transfer conditions are briefly discussed.

  5. Solving the Capacitive Effect in the High-Frequency sweep for Langmuir Probe in SYMPLE

    International Nuclear Information System (INIS)

    Pramila; Patel, J J; Rajpal, R; Hansalia, C J; Anitha, V P; Sathyanarayana, K

    2017-01-01

    Langmuir Probe based measurements need to be routinely carried out to measure various plasma parameters such as the electron density (n e ), the electron temperature (T e ), the floating potential (V f ), and the plasma potential (V p ). For this, the diagnostic electronics along with the biasing power supplies is installed in standard industrial racks with a 2KV isolation transformer. The Signal Conditioning Electronics (SCE) system is populated inside the 4U-chassis based system with the front-end electronics, designed using high common mode differential amplifiers which can measure small differential signal in presence of high common mode dc- bias or ac ramp voltage used for biasing the probes. DC-biasing of the probe is most common method for getting its I-V characteristic but method of biasing the probe with a sweep at high frequency encounters the problem of corruption of signal due to capacitive effect specially when the sweep period and the discharge time is very fast and die down in the order of μs or lesser. This paper presents and summarises the method of removing such effects encountered while measuring the probe current. (paper)

  6. Solving the Capacitive Effect in the High-Frequency sweep for Langmuir Probe in SYMPLE

    Science.gov (United States)

    Pramila; Patel, J. J.; Rajpal, R.; Hansalia, C. J.; Anitha, V. P.; Sathyanarayana, K.

    2017-04-01

    Langmuir Probe based measurements need to be routinely carried out to measure various plasma parameters such as the electron density (ne), the electron temperature (Te), the floating potential (Vf), and the plasma potential (Vp). For this, the diagnostic electronics along with the biasing power supplies is installed in standard industrial racks with a 2KV isolation transformer. The Signal Conditioning Electronics (SCE) system is populated inside the 4U-chassis based system with the front-end electronics, designed using high common mode differential amplifiers which can measure small differential signal in presence of high common mode dc- bias or ac ramp voltage used for biasing the probes. DC-biasing of the probe is most common method for getting its I-V characteristic but method of biasing the probe with a sweep at high frequency encounters the problem of corruption of signal due to capacitive effect specially when the sweep period and the discharge time is very fast and die down in the order of μs or lesser. This paper presents and summarises the method of removing such effects encountered while measuring the probe current.

  7. The characteristics of void distribution in spalled high purity copper cylinder under sweeping detonation

    Science.gov (United States)

    Yang, Yang; Jiang, Zhi; Chen, Jixinog; Guo, Zhaoliang; Tang, Tiegang; Hu, Haibo

    2018-03-01

    The effects of different peak compression stresses (2-5 GPa) on the spallation behaviour of high purity copper cylinder during sweeping detonation were examined by Electron Backscatter Diffraction Microscopy, Doppler Pins System and Optical Microscopy techniques. The velocity history of inner surface and the characteristics of void distributions in spalled copper cylinder were investigated. The results indicated that the spall strength of copper in these experiments was less than that revealed in previous reports concerning plate impact loading. The geometry of cylindrical copper and the obliquity of incident shock during sweeping detonation may be the main reasons. Different loading stresses seemed to be responsible for the characteristics of the resultant damage fields, and the maximum damage degree increased with increasing shock stress. Spall planes in different cross-sections of sample loaded with the same shock stress of 3.29 GPa were found, and the distance from the initiation end has little effect on the maximum damage degree (the maximum damage range from 12 to 14%), which means that the spallation behaviour was stable along the direction parallel to the detonation propagation direction under the same shock stress.

  8. An automated phase correction algorithm for retrieving permittivity and permeability of electromagnetic metamaterials

    Directory of Open Access Journals (Sweden)

    Z. X. Cao

    2014-06-01

    Full Text Available To retrieve complex-valued effective permittivity and permeability of electromagnetic metamaterials (EMMs based on resonant effect from scattering parameters using a complex logarithmic function is not inevitable. When complex values are expressed in terms of magnitude and phase, an infinite number of permissible phase angles is permissible due to the multi-valued property of complex logarithmic functions. Special attention needs to be paid to ensure continuity of the effective permittivity and permeability of lossy metamaterials as frequency sweeps. In this paper, an automated phase correction (APC algorithm is proposed to properly trace and compensate phase angles of the complex logarithmic function which may experience abrupt phase jumps near the resonant frequency region of the concerned EMMs, and hence the continuity of the effective optical properties of lossy metamaterials is ensured. The algorithm is then verified to extract effective optical properties from the simulated scattering parameters of the four different types of metamaterial media: a cut-wire cell array, a split ring resonator (SRR cell array, an electric-LC (E-LC resonator cell array, and a combined SRR and wire cell array respectively. The results demonstrate that the proposed algorithm is highly accurate and effective.

  9. Minaret, a deterministic neutron transport solver for nuclear core calculations

    Energy Technology Data Exchange (ETDEWEB)

    Moller, J-Y.; Lautard, J-J., E-mail: jean-yves.moller@cea.fr, E-mail: jean-jacques.lautard@cea.fr [CEA - Centre de Saclay , Gif sur Yvette (France)

    2011-07-01

    We present here MINARET a deterministic transport solver for nuclear core calculations to solve the steady state Boltzmann equation. The code follows the multi-group formalism to discretize the energy variable. It uses discrete ordinate method to deal with the angular variable and a DGFEM to solve spatially the Boltzmann equation. The mesh is unstructured in 2D and semi-unstructured in 3D (cylindrical). Curved triangles can be used to fit the exact geometry. For the curved elements, two different sets of basis functions can be used. Transport solver is accelerated with a DSA method. Diffusion and SPN calculations are made possible by skipping the transport sweep in the source iteration. The transport calculations are parallelized with respect to the angular directions. Numerical results are presented for simple geometries and for the C5G7 Benchmark, JHR reactor and the ESFR (in 2D and 3D). Straight and curved finite element results are compared. (author)

  10. Minaret, a deterministic neutron transport solver for nuclear core calculations

    International Nuclear Information System (INIS)

    Moller, J-Y.; Lautard, J-J.

    2011-01-01

    We present here MINARET a deterministic transport solver for nuclear core calculations to solve the steady state Boltzmann equation. The code follows the multi-group formalism to discretize the energy variable. It uses discrete ordinate method to deal with the angular variable and a DGFEM to solve spatially the Boltzmann equation. The mesh is unstructured in 2D and semi-unstructured in 3D (cylindrical). Curved triangles can be used to fit the exact geometry. For the curved elements, two different sets of basis functions can be used. Transport solver is accelerated with a DSA method. Diffusion and SPN calculations are made possible by skipping the transport sweep in the source iteration. The transport calculations are parallelized with respect to the angular directions. Numerical results are presented for simple geometries and for the C5G7 Benchmark, JHR reactor and the ESFR (in 2D and 3D). Straight and curved finite element results are compared. (author)

  11. High-sweeping-speed optically synchronized dual-channel terahertz-signal generator for driving a superconducting tunneling mixer and its application to active gas sensing.

    Science.gov (United States)

    Oh, Kyoung-Hwan; Shimizu, Naofumi; Kohjiro, Satoshi; Kikuchi, Ken'ichi; Wakatsuki, Atsushi; Kukutsu, Naoya; Kado, Yuichi

    2009-10-12

    We propose a high-sweeping-speed optically synchronized dual-channel terahertz (THz) signal generator for an active gas-sensing system with a superconductor-insulator-superconductor (SIS) mixer. The generator can sweep a frequency range from 200 to 500 GHz at a speed of 375 GHz/s and a frequency resolution of 500 MHz. With the developed gas-sensing system, a gas-absorption-line measurement was successfully carried out with N(2)O gas in that frequency range.

  12. Experimental transonic flutter characteristics of two 72 deg-sweep delta-wing models

    Science.gov (United States)

    Doggett, Robert V., Jr.; Soistmann, David L.; Spain, Charles V.; Parker, Ellen C.; Silva, Walter A.

    1989-01-01

    Transonic flutter boundaries are presented for two simple, 72 deg. sweep, low-aspect-ratio wing models. One model was an aspect-ratio 0.65 delta wing; the other model was an aspect-ratio 0.54 clipped-delta wing. Flutter boundaries for the delta wing are presented for the Mach number range of 0.56 to 1.22. Flutter boundaries for the clipped-delta wing are presented for the Mach number range of 0.72 to 0.95. Selected vibration characteristics of the models are also presented.

  13. A TV camera system for digitizing single shot oscillograms at sweep rate of 0.1 ns/cm

    International Nuclear Information System (INIS)

    Kienlen, M.; Knispel, G.; Miehe, J.A.; Sipp, B.

    1976-01-01

    A TV camera digitizing system associated with a 5 GHz photocell-oscilloscope apparatus allows the digitizing of single shot oscillograms; with an oscilloscope sweep rate of 0.1 ns/cm an accuracy on time measurements of 4 ps is obtained [fr

  14. Thermo-mechanical design of a CW sweep plate emittance scanner

    International Nuclear Information System (INIS)

    Rathke, J.; Peacock, M.; Sredniawski, J.

    1996-01-01

    A sweep plate emittance scanner for use with high power, continuous wave (CW) beams has been designed, fabricated and commissioned at Northrop Grumman. The design is capable of scanning beams of up to 20 kW beam power with a spot diameter as small as 2 cm. The scanner pod is mounted on a ball screw driven linear bearing table that is driven through the beam by a stepper motor at velocities up to 30 cm/sec. This paper presents the thermo-mechanical analysis of the pod moving through a gaussian beam and the details of the mechanical design of the pod and motion system. Analyses to determine scanner cooling schemes and structural materials are presented. (author)

  15. Neutronic rebalance algorithms for SIMMER

    International Nuclear Information System (INIS)

    Soran, P.D.

    1976-05-01

    Four algorithms to solve the two-dimensional neutronic rebalance equations in SIMMER are investigated. Results of the study are presented and indicate that a matrix decomposition technique with a variable convergence criterion is the best solution algorithm in terms of accuracy and calculational speed. Rebalance numerical stability problems are examined. The results of the study can be applied to other neutron transport codes which use discrete ordinates techniques

  16. Systematic errors due to linear congruential random-number generators with the Swendsen-Wang algorithm: a warning.

    Science.gov (United States)

    Ossola, Giovanni; Sokal, Alan D

    2004-08-01

    We show that linear congruential pseudo-random-number generators can cause systematic errors in Monte Carlo simulations using the Swendsen-Wang algorithm, if the lattice size is a multiple of a very large power of 2 and one random number is used per bond. These systematic errors arise from correlations within a single bond-update half-sweep. The errors can be eliminated (or at least radically reduced) by updating the bonds in a random order or in an aperiodic manner. It also helps to use a generator of large modulus (e.g., 60 or more bits).

  17. Innovative electron transport methods in EGS5

    International Nuclear Information System (INIS)

    Bielajew, A.F.; Wilderman, S.J.

    2000-01-01

    The initial formulation of a Monte Carlo scheme for the transport of high-energy (>≅ 100 keV) electrons was established by Berger in 1963. Calling his method the 'condensed history theory', Berger combined the theoretical results of the previous generation of research into developing approximate solutions of the Boltzmann transport equation with numerical algorithms for exploiting the power of computers to permit iterative, piece-wise solution of the transport equation in a computationally intensive but much less approximate fashion. The methods devised by Berger, with comparatively little modification, provide the foundation of all present day Monte Carlo electron transport simulation algorithms. Only in the last 15 years, beginning with the development and publication of the PRESTA algorithm, has there been a significant revisitation of the problem of simulating electron transport within the condensed history framework. Research in this area is ongoing, highly active, and far from complete. It presents an enormous challenge, demanding derivation of new analytical transport solutions based on underlying fundamental interaction mechanisms, intuitive insight in the development of computer algorithms, and state of the art computer science skills in order to permit deployment of these techniques in an efficient manner. The EGS5 project, a modern ground-up rewrite of the EGS4 code, is now in the design phase. EGS5 will take modern photon and electron transport algorithms and deploy them in an easy-to-maintain, modern computer language-ANSI-standard C ++. Moreover, the well-known difficulties of applying EGS4 to practical geometries (geometry code development, tally routine design) should be made easier and more intuitive through the use of a visual user interface being designed by Quantum Research, Inc., work that is presented elsewhere in this conference. This report commences with a historical review of electron transport models culminating with the proposal of a

  18. A DOUBLE-RING ALGORITHM FOR MODELING SOLAR ACTIVE REGIONS: UNIFYING KINEMATIC DYNAMO MODELS AND SURFACE FLUX-TRANSPORT SIMULATIONS

    International Nuclear Information System (INIS)

    Munoz-Jaramillo, Andres; Martens, Petrus C. H.; Nandy, Dibyendu; Yeates, Anthony R.

    2010-01-01

    The emergence of tilted bipolar active regions (ARs) and the dispersal of their flux, mediated via processes such as diffusion, differential rotation, and meridional circulation, is believed to be responsible for the reversal of the Sun's polar field. This process (commonly known as the Babcock-Leighton mechanism) is usually modeled as a near-surface, spatially distributed α-effect in kinematic mean-field dynamo models. However, this formulation leads to a relationship between polar field strength and meridional flow speed which is opposite to that suggested by physical insight and predicted by surface flux-transport simulations. With this in mind, we present an improved double-ring algorithm for modeling the Babcock-Leighton mechanism based on AR eruption, within the framework of an axisymmetric dynamo model. Using surface flux-transport simulations, we first show that an axisymmetric formulation-which is usually invoked in kinematic dynamo models-can reasonably approximate the surface flux dynamics. Finally, we demonstrate that our treatment of the Babcock-Leighton mechanism through double-ring eruption leads to an inverse relationship between polar field strength and meridional flow speed as expected, reconciling the discrepancy between surface flux-transport simulations and kinematic dynamo models.

  19. Monte Carlo Transport for Electron Thermal Transport

    Science.gov (United States)

    Chenhall, Jeffrey; Cao, Duc; Moses, Gregory

    2015-11-01

    The iSNB (implicit Schurtz Nicolai Busquet multigroup electron thermal transport method of Cao et al. is adapted into a Monte Carlo transport method in order to better model the effects of non-local behavior. The end goal is a hybrid transport-diffusion method that combines Monte Carlo Transport with a discrete diffusion Monte Carlo (DDMC). The hybrid method will combine the efficiency of a diffusion method in short mean free path regions with the accuracy of a transport method in long mean free path regions. The Monte Carlo nature of the approach allows the algorithm to be massively parallelized. Work to date on the method will be presented. This work was supported by Sandia National Laboratory - Albuquerque and the University of Rochester Laboratory for Laser Energetics.

  20. Carbon impurity transport around limiters in the DITE tokamak

    International Nuclear Information System (INIS)

    Pitcher, C.S.; Stangeby, P.C.; Goodall, D.H.J.; Matthews, G.F.; McCracken, G.M.

    1989-01-01

    The transport of impurity ions originating at the limiter in a tokamak is critically dependent on the location of the ion in the boundary plasma. In the confined plasma, just inboard of the limiter, impurity ions will disperse freely into the discharge whilst in the scrape-off layer the pre-sheath plasma flow and the associated ambipolar electric field may tend to sweep impurities back to the limiter surface. In this paper we have studied, both by experiment and by theory, the transport of carbon impurity ions in the vicinity of the limiter. By comparing experimental measurements of the spatial distributions of impurities around the limiter with that predicted from a Monte Carlo computer code it appears that the parallel dispersal on closed field lines in the confined plasma is consistent with classical transport processes and that in the scrape-off layer the dispersal is indeed impeded by the pre-sheath plasma flow. (orig.)

  1. Ultrasonic flow-through filtration of microparticles in a microfluidic channel using frequency sweep technique

    International Nuclear Information System (INIS)

    Seo, Dae Cheol; Ahn, Bong Young; Cho, Seung Hyun; Siddique, A. K. M. Ariful Haque; Kim, Cheol Gi

    2013-01-01

    Many studies have been conducted on the filtration of microparticles using the acoustic radiation force of ultrasonic standing wave. The present work concerns a flow-through particle filtration method by utilizing frequency varying ultrasound. The periodical frequency sweep of the ultrasonic standing wave translocates particles across a microchannel, where particles in fluid flow are filtrated without barriers. The present filtration technique in a microfluidic channel was proposed conceptually in the 1990s. However, its experimental realization on actual particles in a microfluidic channel has not been carried out in a notable way. Several sizes of polystyrene microspheres (10 µm to 90 µm) and silicon carbide (SiC) particles (37 µm) suspended in water were applied as a test sample. For filtration of those particles, a Y-branched microfluidic channel with one inlet and two outlets was made out of steel and acrylic as a form of modulized device. Ultrasound of a few MHz in band frequency (1.75 MHz to 3.05 MHz) was transmitted into one side of the channel wall to generate a standing wave field in fluid flow. The periodical frequency sweep operation showed successful filtration performance, whereby particles in water flowed into one outlet and purified water flowed into the other outlet of the Y branch of the channel.

  2. Selective sweeps in growing microbial colonies

    International Nuclear Information System (INIS)

    Korolev, Kirill S; Müller, Melanie J I; Murray, Andrew W; Nelson, David R; Karahan, Nilay; Hallatschek, Oskar

    2012-01-01

    Evolutionary experiments with microbes are a powerful tool to study mutations and natural selection. These experiments, however, are often limited to the well-mixed environments of a test tube or a chemostat. Since spatial organization can significantly affect evolutionary dynamics, the need is growing for evolutionary experiments in spatially structured environments. The surface of a Petri dish provides such an environment, but a more detailed understanding of microbial growth on Petri dishes is necessary to interpret such experiments. We formulate a simple deterministic reaction–diffusion model, which successfully predicts the spatial patterns created by two competing species during colony expansion. We also derive the shape of these patterns analytically without relying on microscopic details of the model. In particular, we find that the relative fitness of two microbial strains can be estimated from the logarithmic spirals created by selective sweeps. The theory is tested with strains of the budding yeast Saccharomyces cerevisiae for spatial competitions with different initial conditions and for a range of relative fitnesses. The reaction–diffusion model also connects the microscopic parameters like growth rates and diffusion constants with macroscopic spatial patterns and predicts the relationship between fitness in liquid cultures and on Petri dishes, which we confirmed experimentally. Spatial sector patterns therefore provide an alternative fitness assay to the commonly used liquid culture fitness assays. (paper)

  3. Selective sweeps in growing microbial colonies

    Science.gov (United States)

    Korolev, Kirill S.; Müller, Melanie J. I.; Karahan, Nilay; Murray, Andrew W.; Hallatschek, Oskar; Nelson, David R.

    2012-04-01

    Evolutionary experiments with microbes are a powerful tool to study mutations and natural selection. These experiments, however, are often limited to the well-mixed environments of a test tube or a chemostat. Since spatial organization can significantly affect evolutionary dynamics, the need is growing for evolutionary experiments in spatially structured environments. The surface of a Petri dish provides such an environment, but a more detailed understanding of microbial growth on Petri dishes is necessary to interpret such experiments. We formulate a simple deterministic reaction-diffusion model, which successfully predicts the spatial patterns created by two competing species during colony expansion. We also derive the shape of these patterns analytically without relying on microscopic details of the model. In particular, we find that the relative fitness of two microbial strains can be estimated from the logarithmic spirals created by selective sweeps. The theory is tested with strains of the budding yeast Saccharomyces cerevisiae for spatial competitions with different initial conditions and for a range of relative fitnesses. The reaction-diffusion model also connects the microscopic parameters like growth rates and diffusion constants with macroscopic spatial patterns and predicts the relationship between fitness in liquid cultures and on Petri dishes, which we confirmed experimentally. Spatial sector patterns therefore provide an alternative fitness assay to the commonly used liquid culture fitness assays.

  4. An improved clustering algorithm based on reverse learning in intelligent transportation

    Science.gov (United States)

    Qiu, Guoqing; Kou, Qianqian; Niu, Ting

    2017-05-01

    With the development of artificial intelligence and data mining technology, big data has gradually entered people's field of vision. In the process of dealing with large data, clustering is an important processing method. By introducing the reverse learning method in the clustering process of PAM clustering algorithm, to further improve the limitations of one-time clustering in unsupervised clustering learning, and increase the diversity of clustering clusters, so as to improve the quality of clustering. The algorithm analysis and experimental results show that the algorithm is feasible.

  5. Comparing genetic algorithm and particle swarm optimization for solving capacitated vehicle routing problem

    Science.gov (United States)

    Iswari, T.; Asih, A. M. S.

    2018-04-01

    In the logistics system, transportation plays an important role to connect every element in the supply chain, but it can produces the greatest cost. Therefore, it is important to make the transportation costs as minimum as possible. Reducing the transportation cost can be done in several ways. One of the ways to minimizing the transportation cost is by optimizing the routing of its vehicles. It refers to Vehicle Routing Problem (VRP). The most common type of VRP is Capacitated Vehicle Routing Problem (CVRP). In CVRP, the vehicles have their own capacity and the total demands from the customer should not exceed the capacity of the vehicle. CVRP belongs to the class of NP-hard problems. These NP-hard problems make it more complex to solve such that exact algorithms become highly time-consuming with the increases in problem sizes. Thus, for large-scale problem instances, as typically found in industrial applications, finding an optimal solution is not practicable. Therefore, this paper uses two kinds of metaheuristics approach to solving CVRP. Those are Genetic Algorithm and Particle Swarm Optimization. This paper compares the results of both algorithms and see the performance of each algorithm. The results show that both algorithms perform well in solving CVRP but still needs to be improved. From algorithm testing and numerical example, Genetic Algorithm yields a better solution than Particle Swarm Optimization in total distance travelled.

  6. High-spatial-resolution localization algorithm based on cascade deconvolution in a distributed Sagnac interferometer invasion monitoring system.

    Science.gov (United States)

    Pi, Shaohua; Wang, Bingjie; Zhao, Jiang; Sun, Qi

    2016-10-10

    In the Sagnac fiber optic interferometer system, the phase difference signal can be illustrated as a convolution of the waveform of the invasion with its occurring-position-associated transfer function h(t); deconvolution is introduced to improve the spatial resolution of the localization. In general, to get a 26 m spatial resolution at a sampling rate of 4×106  s-1, the algorithm should mainly go through three steps after the preprocessing operations. First, the decimated phase difference signal is transformed from the time domain into the real cepstrum domain, where a probable region of invasion distance can be ascertained. Second, a narrower region of invasion distance is acquired by coarsely assuming and sweeping a transfer function h(t) within the probable region and examining where the restored invasion waveform x(t) gets its minimum standard deviation. Third, fine sweeping the narrow region point by point with the same criteria is used to get the final localization. Also, the original waveform of invasion can be restored for the first time as a by-product, which provides more accurate and pure characteristics for further processing, such as subsequent pattern recognition.

  7. Quarter-Sweep Iteration Concept on Conjugate Gradient Normal Residual Method via Second Order Quadrature - Finite Difference Schemes for Solving Fredholm Integro-Differential Equations

    International Nuclear Information System (INIS)

    Aruchunan, E.

    2015-01-01

    In this paper, we have examined the effectiveness of the quarter-sweep iteration concept on conjugate gradient normal residual (CGNR) iterative method by using composite Simpson's (CS) and finite difference (FD) discretization schemes in solving Fredholm integro-differential equations. For comparison purposes, Gauss- Seidel (GS) and the standard or full- and half-sweep CGNR methods namely FSCGNR and HSCGNR are also presented. To validate the efficacy of the proposed method, several analyses were carried out such as computational complexity and percentage reduction on the proposed and existing methods. (author)

  8. Grain boundary sweeping and dissolution effects on fission product behavior under severe fuel damage accident conditions

    International Nuclear Information System (INIS)

    Rest, J.

    1985-10-01

    The theoretical FASTGRASS-VFP model has been used in the interpretation of fission gas, iodine, tellurium, and cesium release from severe-fuel-damage (SFD) tests performed in the PBF reactor in Idaho. A theory of grain boundary sweeping of gas bubbles, gas bubble behavior during fuel liquefaction (destruction of grain boundaries due to formation of a U-rich melt phase), and during U-Zr eutectic melting has been included within the FASTGRASS-VFP formalism. The grain-boundary-sweeping theory considers the interaction between the moving grain boundary and two distinct size classes of bubbles, those on grain faces and on grain edges. The theory of the effects of fuel liquefaction and U-Zr eutectic melting on fission product behavior considers the migration and coalescence of fission gas bubbles in either molten uranium, or a zircaloy-uranium eutectic melt. The FASTGRASS-VFP predictions, measured release rates from the above tests, and previously published release rates are compared and differences between fission product behavior in trace-irradiated and in normally irradiated fuel are highlighted

  9. Fourier analysis of a new P1 synthetic acceleration for Sn transport equations

    International Nuclear Information System (INIS)

    Turcksin, B.; Ragusa, J. C.

    2010-10-01

    In this work, is derived a new P1 synthetic acceleration scheme (P1SA) for the S N transport equation and analyze its convergence properties through the means of a Fourier analysis. The Fourier analysis is carried out for both continuous (i.e., not spatially discretized) S N equations and linear discontinuous Fem discretization. We show, thanks to the continuous analysis, that the scheme is unstable when the anisotropy is important (μ - >0.5). However, the discrete analysis shows that when cells are large in comparison to the mean free path, the spectral radius decreases and the acceleration scheme becomes effective, even for highly anisotropic scattering. In charged particles transport, scattering is highly anisotropic and mean free paths are very small and, thus, this scheme could be of interest. To use the P1SA when cells are small and anisotropy is important, the scheme is modified by altering the update of the accelerated flux or by using either K transport sweeps before the application of P1SA. The update scheme performs well as long as μ - - ≥0.9, the modified update scheme is unstable. The multiple transport sweeps scheme is convergent with an arbitrary μ - but the spectral radius increases when scattering is isotropic. When anisotropic increases, the frequency of use of the acceleration scheme needs to be decreased. Even if the P1SA is used less often, the spectral radius is significantly smaller when compared with a method that does not use it for high anisotropy (μ - ≥0.5). It is interesting to notice that using P1SA every two iterations gives the same spectral radius than the update method when μ - ≥0.5 but it is much less efficient when μ - <0.5. (Author)

  10. Parallel thermal radiation transport in two dimensions

    International Nuclear Information System (INIS)

    Smedley-Stevenson, R.P.; Ball, S.R.

    2003-01-01

    This paper describes the distributed memory parallel implementation of a deterministic thermal radiation transport algorithm in a 2-dimensional ALE hydrodynamics code. The parallel algorithm consists of a variety of components which are combined in order to produce a state of the art computational capability, capable of solving large thermal radiation transport problems using Blue-Oak, the 3 Tera-Flop MPP (massive parallel processors) computing facility at AWE (United Kingdom). Particular aspects of the parallel algorithm are described together with examples of the performance on some challenging applications. (author)

  11. Parallel thermal radiation transport in two dimensions

    Energy Technology Data Exchange (ETDEWEB)

    Smedley-Stevenson, R.P.; Ball, S.R. [AWE Aldermaston (United Kingdom)

    2003-07-01

    This paper describes the distributed memory parallel implementation of a deterministic thermal radiation transport algorithm in a 2-dimensional ALE hydrodynamics code. The parallel algorithm consists of a variety of components which are combined in order to produce a state of the art computational capability, capable of solving large thermal radiation transport problems using Blue-Oak, the 3 Tera-Flop MPP (massive parallel processors) computing facility at AWE (United Kingdom). Particular aspects of the parallel algorithm are described together with examples of the performance on some challenging applications. (author)

  12. Los Alamos neutral particle transport codes: New and enhanced capabilities

    International Nuclear Information System (INIS)

    Alcouffe, R.E.; Baker, R.S.; Brinkley, F.W.; Clark, B.A.; Koch, K.R.; Marr, D.R.

    1992-01-01

    We present new developments in Los Alamos discrete-ordinates transport codes and introduce THREEDANT, the latest in the series of Los Alamos discrete ordinates transport codes. THREEDANT solves the multigroup, neutral-particle transport equation in X-Y-Z and R-Θ-Z geometries. THREEDANT uses computationally efficient algorithms: Diffusion Synthetic Acceleration (DSA) is used to accelerate the convergence of transport iterations, the DSA solution is accelerated using the multigrid technique. THREEDANT runs on a wide range of computers, from scientific workstations to CRAY supercomputers. The algorithms are highly vectorized on CRAY computers. Recently, the THREEDANT transport algorithm was implemented on the massively parallel CM-2 computer, with performance that is comparable to a single-processor CRAY-YMP We present the results of THREEDANT analysis of test problems

  13. The converged Sn algorithm for nuclear criticality

    International Nuclear Information System (INIS)

    Ganapol, B. D.; Hadad, K.

    2009-01-01

    A new discrete ordinates algorithm to determine the multiplication factor of a 1D nuclear reactor, based on Bengt Carlson's S n method, is presented. The algorithm applies the Romberg and Wynn-epsilon accelerators to accelerate a 1D, one-group S n solution to its asymptotic limit. We demonstrate the feasibility of the Converged Sn (CSn) solution on several one-group criticality benchmark compilations. The new formulation is especially convenient since it enables highly accurate critical fluxes and eigenvalues using the most fundamental transport algorithm. (authors)

  14. Public transport optimisation emphasising passengers’ travel behaviour

    DEFF Research Database (Denmark)

    Jensen, Jens Parbo

    to the case where the two problems are solved sequentially without taking into account interdependencies. Figure 1 - Planning public transport The PhD study develops a metaheuristic algorithm to adapt the line plan configuration in order better to match passengers’ travel demand in terms of transfers as well......Passengers in public transport complaining about their travel experiences are not uncommon. This might seem counterintuitive since several operators worldwide are presenting better key performance indicators year by year. The present PhD study focuses on developing optimisation algorithms...... to enhance the operations of public transport while explicitly emphasising passengers’ travel behaviour and preferences. Similar to economic theory, interactions between supply and demand are omnipresent in the context of public transport operations. In public transport, the demand is represented...

  15. Design of Algorithms for their Use in the Control of Solutes Transport in Contaminated Aquifers; Diseno de algoritmos para su uso en el control del transporte de solutos en acuiferos contaminados

    Energy Technology Data Exchange (ETDEWEB)

    Martinez Najera, Juan Diego [Comision Federal de Electricidad (Mexico)

    2002-06-01

    This paper establishes the theoretical foundations of a mathematical methodology to approach the rehabilitation of aquifers contaminated by dissolved substances, with the assistance of numerical techniques. The derived algorithms are of control or management type, since simultaneously to the predictive numerical solution of the solute transport equation, they determine those solutions that fulfil water quality restrictions. The controlling variable is the concentration of the polluting agent dissolved in the flow field. The considerations are kinematics because they take into account the advection and dispersion terms, but they also considerate the first order kinetic sorption model and the sources/sinks for the concentration. We describe the physical arguments and mathematical theory of subdiferentials necessary to establish the control problem of initial and boundary values for the solutes transport equation; afterwards, the primal variational model and the mixed of dual internal control as well as the formal discrete version of both formulations are obtained, so that solution algorithms of finite element semi discrete type are generated. Due to the hyperbolic-parabolic character of the transport equation, when the advective tem is dominant, in this work it is approximated by means of the lkeda's partial upwind technique. To prove the theory a hypothetical example is presented, and we analyze the two possible cases for the concentration of a polluting agent: when it dose not exceed and when it escapes the regulator limits of water quality. In both situations the primal and mixed algorithms determine the appropriate numerical solutions of each kind of problem. [Spanish] Este trabajo establece los fundamentos teoricos de una metodologia matematica para abordar la rehabilitacion de mantos acuiferos contaminados por sustancias disueltas, con la asistencia de tecnicas numericas. Los algoritmos que se derivan son de control o de manejo, ya que inmerso a la

  16. Fuzzy Algorithm for the Detection of Incidents in the Transport System

    Science.gov (United States)

    Nikolaev, Andrey B.; Sapego, Yuliya S.; Jakubovich, Anatolij N.; Berner, Leonid I.; Stroganov, Victor Yu.

    2016-01-01

    In the paper it's proposed an algorithm for the management of traffic incidents, aimed at minimizing the impact of incidents on the road traffic in general. The proposed algorithm is based on the theory of fuzzy sets and provides identification of accidents, as well as the adoption of appropriate measures to address them as soon as possible. A…

  17. A fast marching algorithm for the factored eikonal equation

    Energy Technology Data Exchange (ETDEWEB)

    Treister, Eran, E-mail: erantreister@gmail.com [Department of Earth and Ocean Sciences, The University of British Columbia, Vancouver, BC (Canada); Haber, Eldad, E-mail: haber@math.ubc.ca [Department of Earth and Ocean Sciences, The University of British Columbia, Vancouver, BC (Canada); Department of Mathematics, The University of British Columbia, Vancouver, BC (Canada)

    2016-11-01

    The eikonal equation is instrumental in many applications in several fields ranging from computer vision to geoscience. This equation can be efficiently solved using the iterative Fast Sweeping (FS) methods and the direct Fast Marching (FM) methods. However, when used for a point source, the original eikonal equation is known to yield inaccurate numerical solutions, because of a singularity at the source. In this case, the factored eikonal equation is often preferred, and is known to yield a more accurate numerical solution. One application that requires the solution of the eikonal equation for point sources is travel time tomography. This inverse problem may be formulated using the eikonal equation as a forward problem. While this problem has been solved using FS in the past, the more recent choice for applying it involves FM methods because of the efficiency in which sensitivities can be obtained using them. However, while several FS methods are available for solving the factored equation, the FM method is available only for the original eikonal equation. In this paper we develop a Fast Marching algorithm for the factored eikonal equation, using both first and second order finite-difference schemes. Our algorithm follows the same lines as the original FM algorithm and requires the same computational effort. In addition, we show how to obtain sensitivities using this FM method and apply travel time tomography, formulated as an inverse factored eikonal equation. Numerical results in two and three dimensions show that our algorithm solves the factored eikonal equation efficiently, and demonstrate the achieved accuracy for computing the travel time. We also demonstrate a recovery of a 2D and 3D heterogeneous medium by travel time tomography using the eikonal equation for forward modeling and inversion by Gauss–Newton.

  18. Dynamic control of low-Z material deposition and tungsten erosion by strike point sweeping on DIII-D

    Directory of Open Access Journals (Sweden)

    J. Guterl

    2017-08-01

    Full Text Available Carbon deposition on tungsten between ELMs was investigated in DIII-D in semi-attached/detached H-mode plasma conditions using fixed outer strike point (OSP positions. Carbon deposition during plasma exposure of tungsten was monitored in-situ by measuring the reflectivity of the tungsten sample surface. No significant carbon deposition, i.e., without strong variations of the reflectivity, was observed during these experiments including discharges at high densities. In contrast, ERO modeling predicts a significant carbon deposition on the tungsten surface for those high density plasma conditions. The surface reflectivity decreases with methane injection, consistent with increased carbon coverage, as expected. The sweeping of OSP leads to a pronounced increase of the surface reflectivity, suggesting that the strike point sweeping may provide an effective means to remove carbon coating from tungsten surface. The ERO modeling however predicts again a regime of carbon deposition for these experiments. The discrepancies between carbon deposition regime predicted by the ERO model and the experimental observations suggest that carbon erosion during ELMs may significantly affect carbon deposition on tungsten.

  19. A Combination of Meta-heuristic and Heuristic Algorithms for the VRP, OVRP and VRP with Simultaneous Pickup and Delivery

    Directory of Open Access Journals (Sweden)

    Maryam Ashouri

    2017-07-01

    Full Text Available Vehicle routing problem (VRP is a Nondeterministic Polynomial Hard combinatorial optimization problem to serve the consumers from central depots and returned back to the originated depots with given vehicles. Furthermore, two of the most important extensions of the VRPs are the open vehicle routing problem (OVRP and VRP with simultaneous pickup and delivery (VRPSPD. In OVRP, the vehicles have not return to the depot after last visit and in VRPSPD, customers require simultaneous delivery and pick-up service. The aim of this paper is to present a combined effective ant colony optimization (CEACO which includes sweep and several local search algorithms which is different with common ant colony optimization (ACO. An extensive numerical experiment is performed on benchmark problem instances addressed in the literature. The computational result shows that suggested CEACO approach not only presented a very satisfying scalability, but also was competitive with other meta-heuristic algorithms in the literature for solving VRP, OVRP and VRPSPD problems. Keywords: Meta-heuristic algorithms, Vehicle Routing Problem, Open Vehicle Routing Problem, Simultaneously Pickup and Delivery, Ant Colony Optimization.

  20. Advanced life support for cardiac arrest beyond the algorithm

    DEFF Research Database (Denmark)

    Rudolph, Søren Steemann; Isbye, Dan Lou; Pfeiffer, Peter

    2018-01-01

    In an advanced emergency medical service all parts of the advanced life support (ALS) algorithm can be provided. This evidence-based algorithm outlines resuscitative efforts for the first 10-15 minutes after cardiac arrest, whereafter the algorithm repeats itself. Restoration of spontaneous...... circulation fails in most cases, but in some circumstances the patient may benefit from additional interventional approaches, in which case transport to hospital with ongoing cardiopulmonary resuscitation is indicated. This paper has summarized treatments outside the ALS algorithm, which may be beneficial...

  1. A parallel sweeping preconditioner for frequency-domain seismic wave propagation

    KAUST Repository

    Poulson, Jack

    2012-09-01

    We present a parallel implementation of Engquist and Ying\\'s sweeping preconditioner, which exploits radiation boundary conditions in order to form an approximate block LDLT factorization of the Helmholtz operator with only O(N4/3) work and an application (and memory) cost of only O(N logN). The approximate factorization is then used as a preconditioner for GMRES, and we show that essentially O(1) iterations are required for convergence, even for the full SEG/EAGE over-thrust model at 30 Hz. In particular, we demonstrate the solution of said problem in a mere 15 minutes on 8192 cores of TACC\\'s Lonestar, which may be the largest-scale 3D heterogeneous Helmholtz calculation to date. Generalizations of our parallel strategy are also briefly discussed for time-harmonic linear elasticity and Maxwell\\'s equations.

  2. Sawtooth driven particle transport in tokamak plasmas

    International Nuclear Information System (INIS)

    Nicolas, T.

    2013-01-01

    The radial transport of particles in tokamaks is one of the most stringent issues faced by the magnetic confinement fusion community, because the fusion power is proportional to the square of the pressure, and also because accumulation of heavy impurities in the core leads to important power losses which can lead to a 'radiative collapse'. Sawteeth and the associated periodic redistribution of the core quantities can significantly impact the radial transport of electrons and impurities. In this thesis, we perform numerical simulations of sawteeth using a nonlinear tridimensional magnetohydrodynamic code called XTOR-2F to study the particle transport induced by sawtooth crashes. We show that the code recovers, after the crash, the fine structures of electron density that are observed with fast-sweeping reflectometry on the JET and TS tokamaks. The presence of these structure may indicate a low efficiency of the sawtooth in expelling the impurities from the core. However, applying the same code to impurity profiles, we show that the redistribution is quantitatively similar to that predicted by Kadomtsev's model, which could not be predicted a priori. Hence finally the sawtooth flushing is efficient in expelling impurities from the core. (author) [fr

  3. Sediment transport modeling in deposited bed sewers: unified form of May's equations using the particle swarm optimization algorithm.

    Science.gov (United States)

    Safari, Mir Jafar Sadegh; Shirzad, Akbar; Mohammadi, Mirali

    2017-08-01

    May proposed two dimensionless parameters of transport (η) and mobility (F s ) for self-cleansing design of sewers with deposited bed condition. The relationships between those two parameters were introduced in conditional form for specific ranges of F s , which makes it difficult to use as a practical tool for sewer design. In this study, using the same experimental data used by May and employing the particle swarm optimization algorithm, a unified equation is recommended based on η and F s . The developed model is compared with original May relationships as well as corresponding models available in the literature. A large amount of data taken from the literature is used for the models' evaluation. The results demonstrate that the developed model in this study is superior to May and other existing models in the literature. Due to the fact that in May's dimensionless parameters more effective variables in the sediment transport process in sewers with deposited bed condition are considered, it is concluded that the revised May equation proposed in this study is a reliable model for sewer design.

  4. Trust Based Algorithm for Candidate Node Selection in Hybrid MANET-DTN

    Directory of Open Access Journals (Sweden)

    Jan Papaj

    2014-01-01

    Full Text Available The hybrid MANET - DTN is a mobile network that enables transport of the data between groups of the disconnected mobile nodes. The network provides benefits of the Mobile Ad-Hoc Networks (MANET and Delay Tolerant Network (DTN. The main problem of the MANET occurs if the communication path is broken or disconnected for some short time period. On the other side, DTN allows sending data in the disconnected environment with respect to higher tolerance to delay. Hybrid MANET - DTN provides optimal solution for emergency situation in order to transport information. Moreover, the security is the critical factor because the data are transported by mobile devices. In this paper, we investigate the issue of secure candidate node selection for transportation of the data in a disconnected environment for hybrid MANET- DTN. To achieve the secure selection of the reliable mobile nodes, the trust algorithm is introduced. The algorithm enables select reliable nodes based on collecting routing information. This algorithm is implemented to the simulator OPNET modeler.

  5. The energy band memory server algorithm for parallel Monte Carlo transport calculations

    International Nuclear Information System (INIS)

    Felker, K.G.; Siegel, A.R.; Smith, K.S.; Romano, P.K.; Forget, B.

    2013-01-01

    An algorithm is developed to significantly reduce the on-node footprint of cross section memory in Monte Carlo particle tracking algorithms. The classic method of per-node replication of cross section data is replaced by a memory server model, in which the read-only lookup tables reside on a remote set of disjoint processors. The main particle tracking algorithm is then modified in such a way as to enable efficient use of the remotely stored data in the particle tracking algorithm. Results of a prototype code on a Blue Gene/Q installation reveal that the penalty for remote storage is reasonable in the context of time scales for real-world applications, thus yielding a path forward for a broad range of applications that are memory bound using current techniques. (authors)

  6. Calculating qP-wave traveltimes in 2-D TTI media by high-order fast sweeping methods with a numerical quartic equation solver

    Science.gov (United States)

    Han, Song; Zhang, Wei; Zhang, Jie

    2017-09-01

    A fast sweeping method (FSM) determines the first arrival traveltimes of seismic waves by sweeping the velocity model in different directions meanwhile applying a local solver. It is an efficient way to numerically solve Hamilton-Jacobi equations for traveltime calculations. In this study, we develop an improved FSM to calculate the first arrival traveltimes of quasi-P (qP) waves in 2-D tilted transversely isotropic (TTI) media. A local solver utilizes the coupled slowness surface of qP and quasi-SV (qSV) waves to form a quartic equation, and solve it numerically to obtain possible traveltimes of qP-wave. The proposed quartic solver utilizes Fermat's principle to limit the range of the possible solution, then uses the bisection procedure to efficiently determine the real roots. With causality enforced during sweepings, our FSM converges fast in a few iterations, and the exact number depending on the complexity of the velocity model. To improve the accuracy, we employ high-order finite difference schemes and derive the second-order formulae. There is no weak anisotropy assumption, and no approximation is made to the complex slowness surface of qP-wave. In comparison to the traveltimes calculated by a horizontal slowness shooting method, the validity and accuracy of our FSM is demonstrated.

  7. SPECIAL LIBRARIES OF FRAGMENTS OF ALGORITHMIC NETWORKS TO AUTOMATE THE DEVELOPMENT OF ALGORITHMIC MODELS

    Directory of Open Access Journals (Sweden)

    V. E. Marley

    2015-01-01

    Full Text Available Summary. The concept of algorithmic models appeared from the algorithmic approach in which the simulated object, the phenomenon appears in the form of process, subject to strict rules of the algorithm, which placed the process of operation of the facility. Under the algorithmic model is the formalized description of the scenario subject specialist for the simulated process, the structure of which is comparable with the structure of the causal and temporal relationships between events of the process being modeled, together with all information necessary for its software implementation. To represent the structure of algorithmic models used algorithmic network. Normally, they were defined as loaded finite directed graph, the vertices which are mapped to operators and arcs are variables, bound by operators. The language of algorithmic networks has great features, the algorithms that it can display indifference the class of all random algorithms. In existing systems, automation modeling based on algorithmic nets, mainly used by operators working with real numbers. Although this reduces their ability, but enough for modeling a wide class of problems related to economy, environment, transport, technical processes. The task of modeling the execution of schedules and network diagrams is relevant and useful. There are many counting systems, network graphs, however, the monitoring process based analysis of gaps and terms of graphs, no analysis of prediction execution schedule or schedules. The library is designed to build similar predictive models. Specifying source data to obtain a set of projections from which to choose one and take it for a new plan.

  8. Effect of current compliance and voltage sweep rate on the resistive switching of HfO2/ITO/Invar structure as measured by conductive atomic force microscopy

    International Nuclear Information System (INIS)

    Wu, You-Lin; Liao, Chun-Wei; Ling, Jing-Jenn

    2014-01-01

    The electrical characterization of HfO 2 /ITO/Invar resistive switching memory structure was studied using conductive atomic force microscopy (AFM) with a semiconductor parameter analyzer, Agilent 4156C. The metal alloy Invar was used as the metal substrate to ensure good ohmic contact with the substrate holder of the AFM. A conductive Pt/Ir AFM tip was placed in direct contact with the HfO 2 surface, such that it acted as the top electrode. Nanoscale current-voltage (I-V) characteristics of the HfO 2 /ITO/Invar structure were measured by applying a ramp voltage through the conductive AFM tip at various current compliances and ramp voltage sweep rates. It was found that the resistance of the low resistance state (RLRS) decreased with increasing current compliance value, but resistance of high resistance state (RHRS) barely changed. However, both the RHRS and RLRS decreased as the voltage sweep rate increased. The reasons for this dependency on current compliance and voltage sweep rate are discussed.

  9. Ion source plasma parameters measurement based on Langmuir probe with commercial frequency sweep

    International Nuclear Information System (INIS)

    Xie, Y.H.; Hu, C.D.; Liu, S.; Shong, S.H.; Jiang, C.C.; Liu, Z.M.

    2010-01-01

    Langmuir probe is one of the main diagnostic tools to measure the plasma parameters in the ion source. In this article, the commercial frequency power, which is sine wave of 50 Hz, was supplied on the Langmuir probe to measure the plasma parameters. The best feature of this probe sweep voltage is that it does not need extra design. The probe I-V characteristic curve can be got in less than 5 ms and the plasma parameters, the electron temperature and the electron density, varying with the time can be got in one plasma discharge of 400 ms.

  10. Phase-Retrieval Uncertainty Estimation and Algorithm Comparison for the JWST-ISIM Test Campaign

    Science.gov (United States)

    Aronstein, David L.; Smith, J. Scott

    2016-01-01

    Phase retrieval, the process of determining the exitpupil wavefront of an optical instrument from image-plane intensity measurements, is the baseline methodology for characterizing the wavefront for the suite of science instruments (SIs) in the Integrated Science Instrument Module (ISIM) for the James Webb Space Telescope (JWST). JWST is a large, infrared space telescope with a 6.5-meter diameter primary mirror. JWST is currently NASA's flagship mission and will be the premier space observatory of the next decade. ISIM contains four optical benches with nine unique instruments, including redundancies. ISIM was characterized at the Goddard Space Flight Center (GSFC) in Greenbelt, MD in a series of cryogenic vacuum tests using a telescope simulator. During these tests, phase-retrieval algorithms were used to characterize the instruments. The objective of this paper is to describe the Monte-Carlo simulations that were used to establish uncertainties (i.e., error bars) for the wavefronts of the various instruments in ISIM. Multiple retrieval algorithms were used in the analysis of ISIM phase-retrieval focus-sweep data, including an iterativetransform algorithm and a nonlinear optimization algorithm. These algorithms emphasize the recovery of numerous optical parameters, including low-order wavefront composition described by Zernike polynomial terms and high-order wavefront described by a point-by-point map, location of instrument best focus, focal ratio, exit-pupil amplitude, the morphology of any extended object, and optical jitter. The secondary objective of this paper is to report on the relative accuracies of these algorithms for the ISIM instrument tests, and a comparison of their computational complexity and their performance on central and graphical processing unit clusters. From a phase-retrieval perspective, the ISIM test campaign includes a variety of source illumination bandwidths, various image-plane sampling criteria above and below the Nyquist- Shannon

  11. Cooperative Transport Planning

    NARCIS (Netherlands)

    Zutt, J.; De Weerdt, M.M.

    2000-01-01

    To test and compare different forms of cooperative planning algorithms developed in the CABS project we use a generic simulator called MARS. Examples in the transportation sector are implemented in this simulator.

  12. The strong selective sweep candidate gene ADRA2C does not explain domestication related changes in the stress response of chickens.

    Directory of Open Access Journals (Sweden)

    Magnus Elfwing

    Full Text Available Analysis of selective sweeps to pinpoint causative genomic regions involved in chicken domestication has revealed a strong selective sweep on chromosome 4 in layer chickens. The autoregulatory α-adrenergic receptor 2C (ADRA2C gene is the closest to the selective sweep and was proposed as an important gene in the domestication of layer chickens. The ADRA2C promoter region was also hypermethylated in comparison to the non-selected ancestor of all domesticated chicken breeds, the Red Junglefowl, further supporting its relevance. In mice the receptor is involved in the fight-or-flight response as it modulates epinephrine release from the adrenals. To investigate the involvement of ADRA2C in chicken domestication, we measured gene expression in the adrenals and radiolabeled receptor ligand in three brain regions comparing the domestic White Leghorn strain with the wild ancestor Red Junglefowl. In adrenals ADRA2C was twofold greater expressed than the related receptor gene ADRA2A, indicating that ADRA2C is the predominant modulator of epinephrine release but no strain differences were measured. In hypothalamus and amygdala, regions associated with the stress response, and in striatum, receptor binding pIC50 values ranged between 8.1-8.4, and the level was not influenced by the genotyped allele. Because chicken strains differ in morphology, physiology and behavior, differences attributed to a single gene may be lost in the noise caused by the heterogeneous genetic background. Therefore an F10 advanced intercross strain between White Leghorn and Red Junglefowl was used to investigate effects of ADRA2C alleles on fear related behaviors and fecundity. We did not find compelling genotype effects in open field, tonic immobility, aerial predator, associative learning or fecundity. Therefore we conclude that ADRA2C is probably not involved in the domestication of the stress response in chicken, and the strong selective sweep is probably caused by selection

  13. A selective sweep on a deleterious mutation in CPT1A in Arctic populations

    KAUST Repository

    Clemente, Florian J.

    2014-11-01

    Arctic populations live in an environment characterized by extreme cold and the absence of plant foods for much of the year and are likely to have undergone genetic adaptations to these environmental conditions in the time they have been living there. Genome-wide selection scans based on genotype data from native Siberians have previously highlighted a 3 Mb chromosome 11 region containing 79 protein-coding genes as the strongest candidates for positive selection in Northeast Siberians. However, it was not possible to determine which of the genes might be driving the selection signal. Here, using whole-genome high-coverage sequence data, we identified the most likely causative variant as a nonsynonymous G>A transition (rs80356779; c.1436C>T [p.Pro479Leu] on the reverse strand) in CPT1A, a key regulator of mitochondrial long-chain fatty-acid oxidation. Remarkably, the derived allele is associated with hypoketotic hypoglycemia and high infant mortality yet occurs at high frequency in Canadian and Greenland Inuits and was also found at 68% frequency in our Northeast Siberian sample. We provide evidence of one of the strongest selective sweeps reported in humans; this sweep has driven this variant to high frequency in circum-Arctic populations within the last 6-23 ka despite associated deleterious consequences, possibly as a result of the selective advantage it originally provided to either a high-fat diet or a cold environment.

  14. Femtosecond Laser Tagging Characterization of a Sweeping Jet Actuator Operating in the Compressible Regime

    Science.gov (United States)

    Peters, Christopher J.; Miles, Richard B.; Burns, Ross A.; Bathel, Brett F.; Jones, Gregory S.; Danehy, Paul M.

    2016-01-01

    A sweeping jet (SWJ) actuator operating over a range of nozzle pressure ratios (NPRs) was characterized with femtosecond laser electronic excitation tagging (FLEET), single hot-wire anemometry (HWA) and high-speed/phase-averaged schlieren. FLEET velocimetry was successfully demonstrated in a highly unsteady, oscillatory flow containing subsonic through supersonic velocities. Qualitative comparisons between FLEET and HWA (which measured mass flux since the flow was compressible) showed relatively good agreement in the external flow profiles. The spreading rate was found to vary from 0.5 to 1.2 depending on the pressure ratio. The precision of FLEET velocity measurements in the external flow field was poorer (is approximately equal to 25 m/s) than reported in a previous study due to the use of relatively low laser fluences, impacting the velocity fluctuation measurements. FLEET enabled velocity measurements inside the device and showed that choking likely occurred for NPR = 2.0, and no internal shockwaves were present. Qualitative oxygen concentration measurements using FLEET were explored in an effort to gauge the jet's mixing with the ambient. The jet was shown to mix well within roughly four throat diameters and mix fully within roughly eight throat diameters. Schlieren provided visualization of the internal and external flow fields and showed that the qualitative structure of the internal flow does not vary with pressure ratio and the sweeping mechanism observed for incompressible NPRs also probably holds for compressible NPRs.

  15. A selective sweep on a deleterious mutation in CPT1A in Arctic populations

    KAUST Repository

    Clemente, Florian J.; Cardona, Alexia; Inchley, Charlotte E.; Peter, Benjamin M.; Jacobs, Guy; Pagani, Luca; Lawson, Daniel John; Antã o, Tiago; Vicente, Má rio; Mitt, Mario; Degiorgio, Michael; Faltyskova, Zuzana; Xue, Yali; Ayub, Qasim; Szpak, Michal; Mä gi, Reedik; Eriksson, Anders; Manica, Andrea; Raghavan, Maanasa; Rasmussen, Morten Arendt Rendt; Rasmussen, Simon B.; Willerslev, Eske; Vidal-Puig, Antonio J.; Tyler-Smith, Chris; Villems, Richard; Nielsen, Rasmus Wedel; Metspalu, Mait; Malyarchuk, Boris A.; Derenko, Miroslava V.; Kivisild, Toomas

    2014-01-01

    Arctic populations live in an environment characterized by extreme cold and the absence of plant foods for much of the year and are likely to have undergone genetic adaptations to these environmental conditions in the time they have been living there. Genome-wide selection scans based on genotype data from native Siberians have previously highlighted a 3 Mb chromosome 11 region containing 79 protein-coding genes as the strongest candidates for positive selection in Northeast Siberians. However, it was not possible to determine which of the genes might be driving the selection signal. Here, using whole-genome high-coverage sequence data, we identified the most likely causative variant as a nonsynonymous G>A transition (rs80356779; c.1436C>T [p.Pro479Leu] on the reverse strand) in CPT1A, a key regulator of mitochondrial long-chain fatty-acid oxidation. Remarkably, the derived allele is associated with hypoketotic hypoglycemia and high infant mortality yet occurs at high frequency in Canadian and Greenland Inuits and was also found at 68% frequency in our Northeast Siberian sample. We provide evidence of one of the strongest selective sweeps reported in humans; this sweep has driven this variant to high frequency in circum-Arctic populations within the last 6-23 ka despite associated deleterious consequences, possibly as a result of the selective advantage it originally provided to either a high-fat diet or a cold environment.

  16. Iterative Observer-based Estimation Algorithms for Steady-State Elliptic Partial Differential Equation Systems

    KAUST Repository

    Majeed, Muhammad Usman

    2017-07-19

    Steady-state elliptic partial differential equations (PDEs) are frequently used to model a diverse range of physical phenomena. The source and boundary data estimation problems for such PDE systems are of prime interest in various engineering disciplines including biomedical engineering, mechanics of materials and earth sciences. Almost all existing solution strategies for such problems can be broadly classified as optimization-based techniques, which are computationally heavy especially when the problems are formulated on higher dimensional space domains. However, in this dissertation, feedback based state estimation algorithms, known as state observers, are developed to solve such steady-state problems using one of the space variables as time-like. In this regard, first, an iterative observer algorithm is developed that sweeps over regular-shaped domains and solves boundary estimation problems for steady-state Laplace equation. It is well-known that source and boundary estimation problems for the elliptic PDEs are highly sensitive to noise in the data. For this, an optimal iterative observer algorithm, which is a robust counterpart of the iterative observer, is presented to tackle the ill-posedness due to noise. The iterative observer algorithm and the optimal iterative algorithm are then used to solve source localization and estimation problems for Poisson equation for noise-free and noisy data cases respectively. Next, a divide and conquer approach is developed for three-dimensional domains with two congruent parallel surfaces to solve the boundary and the source data estimation problems for the steady-state Laplace and Poisson kind of systems respectively. Theoretical results are shown using a functional analysis framework, and consistent numerical simulation results are presented for several test cases using finite difference discretization schemes.

  17. Algorithm development and verification of UASCM for multi-dimension and multi-group neutron kinetics model

    International Nuclear Information System (INIS)

    Si, S.

    2012-01-01

    The Universal Algorithm of Stiffness Confinement Method (UASCM) for neutron kinetics model of multi-dimensional and multi-group transport equations or diffusion equations has been developed. The numerical experiments based on transport theory code MGSNM and diffusion theory code MGNEM have demonstrated that the algorithm has sufficient accuracy and stability. (authors)

  18. A Hybrid Dynamic Programming for Solving Fixed Cost Transportation with Discounted Mechanism

    Directory of Open Access Journals (Sweden)

    Farhad Ghassemi Tari

    2016-01-01

    Full Text Available The problem of allocating different types of vehicles for transporting a set of products from a manufacturer to its depots/cross docks, in an existing transportation network, to minimize the total transportation costs, is considered. The distribution network involves a heterogeneous fleet of vehicles, with a variable transportation cost and a fixed cost in which a discount mechanism is applied on the fixed part of the transportation costs. It is assumed that the number of available vehicles is limited for some types. A mathematical programming model in the form of the discrete nonlinear optimization model is proposed. A hybrid dynamic programming algorithm is developed for finding the optimal solution. To increase the computational efficiency of the solution algorithm, several concepts and routines, such as the imbedded state routine, surrogate constraint concept, and bounding schemes, are incorporated in the dynamic programming algorithm. A real world case problem is selected and solved by the proposed solution algorithm, and the optimal solution is obtained.

  19. Uncertainty analysis of an interfacial area reconstruction algorithm and its application to two group interfacial area transport equation validation

    International Nuclear Information System (INIS)

    Dave, A.J.; Manera, A.; Beyer, M.; Lucas, D.; Prasser, H.-M.

    2016-01-01

    Wire mesh sensors (WMS) are state of the art devices that allow high resolution (in space and time) measurement of 2D void fraction distribution over a wide range of two-phase flow regimes, from bubbly to annular. Data using WMS have been recorded at the Helmholtz-Zentrum Dresden-Rossendorf (HZDR) (Lucas et al., 2010; Beyer et al., 2008; Prasser et al., 2003) for a wide combination of superficial gas and liquid velocities, providing an excellent database for advances in two-phase flow modeling. In two-phase flow, the interfacial area plays an integral role in coupling the mass, momentum and energy transport equations of the liquid and gas phase. While current models used in best-estimate thermal-hydraulic codes (e.g. RELAP5, TRACE, TRACG, etc.) are still based on algebraic correlations for the estimation of the interfacial area in different flow regimes, interfacial area transport equations (IATE) have been proposed to predict the dynamic propagation in space and time of interfacial area (Ishii and Hibiki, 2010). IATE models are still under development and the HZDR WMS experimental data provide an excellent basis for the validation and further advance of these models. The current paper is focused on the uncertainty analysis of algorithms used to reconstruct interfacial area densities from the void-fraction voxel data measured using WMS and their application towards validation efforts of two-group IATE models. In previous research efforts, a surface triangularization algorithm has been developed in order to estimate the surface area of individual bubbles recorded with the WMS, and estimate the interfacial area in the given flow condition. In the present paper, synthetically generated bubbles are used to assess the algorithm’s accuracy. As the interfacial area of the synthetic bubbles are defined by user inputs, the error introduced by the algorithm can be quantitatively obtained. The accuracy of interfacial area measurements is characterized for different bubbles

  20. Uncertainty analysis of an interfacial area reconstruction algorithm and its application to two group interfacial area transport equation validation

    Energy Technology Data Exchange (ETDEWEB)

    Dave, A.J., E-mail: akshayjd@umich.edu [Department of Nuclear Engineering and Rad. Sciences, University of Michigan, Ann Arbor, MI 48105 (United States); Manera, A. [Department of Nuclear Engineering and Rad. Sciences, University of Michigan, Ann Arbor, MI 48105 (United States); Beyer, M.; Lucas, D. [Helmholtz-Zentrum Dresden-Rossendorf, Institute of Fluid Dynamics, 01314 Dresden (Germany); Prasser, H.-M. [Department of Mechanical and Process Engineering, ETH Zurich, 8092 Zurich (Switzerland)

    2016-12-15

    Wire mesh sensors (WMS) are state of the art devices that allow high resolution (in space and time) measurement of 2D void fraction distribution over a wide range of two-phase flow regimes, from bubbly to annular. Data using WMS have been recorded at the Helmholtz-Zentrum Dresden-Rossendorf (HZDR) (Lucas et al., 2010; Beyer et al., 2008; Prasser et al., 2003) for a wide combination of superficial gas and liquid velocities, providing an excellent database for advances in two-phase flow modeling. In two-phase flow, the interfacial area plays an integral role in coupling the mass, momentum and energy transport equations of the liquid and gas phase. While current models used in best-estimate thermal-hydraulic codes (e.g. RELAP5, TRACE, TRACG, etc.) are still based on algebraic correlations for the estimation of the interfacial area in different flow regimes, interfacial area transport equations (IATE) have been proposed to predict the dynamic propagation in space and time of interfacial area (Ishii and Hibiki, 2010). IATE models are still under development and the HZDR WMS experimental data provide an excellent basis for the validation and further advance of these models. The current paper is focused on the uncertainty analysis of algorithms used to reconstruct interfacial area densities from the void-fraction voxel data measured using WMS and their application towards validation efforts of two-group IATE models. In previous research efforts, a surface triangularization algorithm has been developed in order to estimate the surface area of individual bubbles recorded with the WMS, and estimate the interfacial area in the given flow condition. In the present paper, synthetically generated bubbles are used to assess the algorithm’s accuracy. As the interfacial area of the synthetic bubbles are defined by user inputs, the error introduced by the algorithm can be quantitatively obtained. The accuracy of interfacial area measurements is characterized for different bubbles

  1. A Novel Segment-Based Approach for Improving Classification Performance of Transport Mode Detection.

    Science.gov (United States)

    Guvensan, M Amac; Dusun, Burak; Can, Baris; Turkmen, H Irem

    2017-12-30

    Transportation planning and solutions have an enormous impact on city life. To minimize the transport duration, urban planners should understand and elaborate the mobility of a city. Thus, researchers look toward monitoring people's daily activities including transportation types and duration by taking advantage of individual's smartphones. This paper introduces a novel segment-based transport mode detection architecture in order to improve the results of traditional classification algorithms in the literature. The proposed post-processing algorithm, namely the Healing algorithm, aims to correct the misclassification results of machine learning-based solutions. Our real-life test results show that the Healing algorithm could achieve up to 40% improvement of the classification results. As a result, the implemented mobile application could predict eight classes including stationary, walking, car, bus, tram, train, metro and ferry with a success rate of 95% thanks to the proposed multi-tier architecture and Healing algorithm.

  2. Determination of underivatized amino acids to evaluate quality of beer by capillary electrophoresis with online sweeping technique.

    Science.gov (United States)

    Luo, Tian; Ke, Jing; Xie, Yunfei; Dong, Yuming

    2017-10-01

    Capillary electrophoresis (CE) with ultraviolet detection was applied to determine underivatized amino acids in beer, based on the coordination interaction of copper ions and amino acids. An online sweeping technique was combined with CE to improve detection sensitivity. Using the United Nations Food Agriculture Organization/World Health Organization model of essential amino acid pattern and flavor of amino acids, the quality and taste in three kinds of beer were evaluated. It was found that Beer2 had higher quality than the other two kinds and the content of phenylalanine, proline, serine, and isoleucine was relatively large in all three kinds of beers with a great influence on beer flavor. Optimal conditions for separation were as follows: 50mM CuSO 4 at pH 4.40 as buffer; total length of fused silica capillary, 73 cm; effective length, 65 cm; separation voltage, 22.5 kV; and optimized sweeping condition, 70 seconds. In the appropriate range, linearity (r 2  > 0.9989), precision with a relative standard deviation amino acids in beer and to perform quantitative analysis directly without derivatization for the first time. Copyright © 2017. Published by Elsevier B.V.

  3. Area 2. Use Of Engineered Nanoparticle-Stabilized CO2 Foams To Improve Volumetric Sweep Of CO2 EOR Processes

    Energy Technology Data Exchange (ETDEWEB)

    DiCarlo, David [Univ. of Texas, Austin, TX (United States); Huh, Chun [Univ. of Texas, Austin, TX (United States); Johnston, Keith P. [Univ. of Texas, Austin, TX (United States)

    2015-01-31

    The goal of this project was to develop a new CO2 injection enhanced oil recovery (CO2-EOR) process using engineered nanoparticles with optimized surface coatings that has better volumetric sweep efficiency and a wider application range than conventional CO2-EOR processes. The main objectives of this project were to (1) identify the characteristics of the optimal nanoparticles that generate extremely stable CO2 foams in situ in reservoir regions without oil; (2) develop a novel method of mobility control using “self-guiding” foams with smart nanoparticles; and (3) extend the applicability of the new method to reservoirs having a wide range of salinity, temperatures, and heterogeneity. Concurrent with our experimental effort to understand the foam generation and transport processes and foam-induced mobility reduction, we also developed mathematical models to explain the underlying processes and mechanisms that govern the fate of nanoparticle-stabilized CO2 foams in porous media and applied these models to (1) simulate the results of foam generation and transport experiments conducted in beadpack and sandstone core systems, (2) analyze CO2 injection data received from a field operator, and (3) aid with the design of a foam injection pilot test. Our simulator is applicable to near-injection well field-scale foam injection problems and accounts for the effects due to layered heterogeneity in permeability field, foam stabilizing agents effects, oil presence, and shear-thinning on the generation and transport of nanoparticle-stabilized C/W foams. This report presents the details of our experimental and numerical modeling work and outlines the highlights of our findings.

  4. The vertical structure of airflow turbulence characteristics within a boundary layer during wind blown sand transport over a beach

    Science.gov (United States)

    Lee, Z. S.; Baas, A. C.; Jackson, D.; Cooper, J. A.; Lynch, K.; Delgado-Fernandez, I.; Beyers, M.

    2010-12-01

    Recent studies have suggested the significant role of boundary layer turbulence and coherent flow structures on sand transport by wind over beaches and desert dunes. Widespread use of sonic anemometry and high-frequency sand transport sensors and traps have facilitated a move beyond the basic monitoring of shear velocities and bulk sediment transport to more detailed measurements at much higher spatio-temporal resolutions. In this paper we present results of a small-scale point-location field study of boundary layer turbulence and shear stresses conducted under obliquely onshore winds over a beach at Magilligan Strand, Northern Ireland. High-frequency (25 Hz) 3D wind vector measurements were collected at five different heights between 0.13 and 1.67 metres above the bed using sonic anemometry for durations of several hours, and the associated sand transport response was measured using an array of Safires. The wind data are used to investigate the vertical structure of Reynolds shear stresses and burst-sweep event characteristics, as well as a comparison with the standard logarithmic (law-of-the-wall) wind profile. The study explores the identification and selection of a characteristic event duration based on integral time-scales as well as spectral analysis, and includes an assessment of the issues involved with data rotations for yaw, pitch, and roll corrections relative to flow streamlines, and the subsequently derived turbulence parameters based on fluctuating vector components (u’, v’, w’). Results show how the contributions to shear stress and the average pitch of bursts and sweeps changes as a function of height above the bed, indicating the transformation of top-down turbulent eddies as they travel toward the surface. A comparison between the turbulence data and the synchronous sand transport events, meanwhile, reveals the potential effects of enhanced saltation layer roughness feedback on eddies close to the bed.

  5. Detection of undistorted continuous wave (CW) electron paramagnetic resonance (EPR) spectra with non-adiabatic rapid sweep (NARS) of the magnetic field

    Science.gov (United States)

    Kittell, Aaron W.; Camenisch, Theodore G.; Ratke, Joseph J.; Sidabras, Jason W.; Hyde, James S.

    2011-01-01

    A continuous wave (CW) electron paramagnetic resonance (EPR) spectrum is typically displayed as the first harmonic response to the application of 100 kHz magnetic field modulation, which is used to enhance sensitivity by reducing the level of 1/f noise. However, magnetic field modulation of any amplitude causes spectral broadening and sacrifices EPR spectral intensity by at least a factor of two. In the work presented here, a CW rapid-scan spectroscopic technique that avoids these compromises and also provides a means of avoiding 1/f noise is developed. This technique, termed non-adiabatic rapid sweep (NARS) EPR, consists of repetitively sweeping the polarizing magnetic field in a linear manner over a spectral fragment with a small coil at a repetition rate that is sufficiently high that receiver noise, microwave phase noise, and environmental microphonics, each of which has 1/f characteristics, are overcome. Nevertheless, the rate of sweep is sufficiently slow that adiabatic responses are avoided and the spin system is always close to thermal equilibrium. The repetitively acquired spectra from the spectral fragment are averaged. Under these conditions, undistorted pure absorption spectra are obtained without broadening or loss of signal intensity. A digital filter such as a moving average is applied to remove high frequency noise, which is approximately equivalent in bandwidth to use of an integrating time constant in conventional field modulation with lock-in detection. Nitroxide spectra at L- and X-band are presented. PMID:21741868

  6. Portable Health Algorithms Test System

    Science.gov (United States)

    Melcher, Kevin J.; Wong, Edmond; Fulton, Christopher E.; Sowers, Thomas S.; Maul, William A.

    2010-01-01

    A document discusses the Portable Health Algorithms Test (PHALT) System, which has been designed as a means for evolving the maturity and credibility of algorithms developed to assess the health of aerospace systems. Comprising an integrated hardware-software environment, the PHALT system allows systems health management algorithms to be developed in a graphical programming environment, to be tested and refined using system simulation or test data playback, and to be evaluated in a real-time hardware-in-the-loop mode with a live test article. The integrated hardware and software development environment provides a seamless transition from algorithm development to real-time implementation. The portability of the hardware makes it quick and easy to transport between test facilities. This hard ware/software architecture is flexible enough to support a variety of diagnostic applications and test hardware, and the GUI-based rapid prototyping capability is sufficient to support development execution, and testing of custom diagnostic algorithms. The PHALT operating system supports execution of diagnostic algorithms under real-time constraints. PHALT can perform real-time capture and playback of test rig data with the ability to augment/ modify the data stream (e.g. inject simulated faults). It performs algorithm testing using a variety of data input sources, including real-time data acquisition, test data playback, and system simulations, and also provides system feedback to evaluate closed-loop diagnostic response and mitigation control.

  7. Mosaic crystal algorithm for Monte Carlo simulations

    CERN Document Server

    Seeger, P A

    2002-01-01

    An algorithm is presented for calculating reflectivity, absorption, and scattering of mosaic crystals in Monte Carlo simulations of neutron instruments. The algorithm uses multi-step transport through the crystal with an exact solution of the Darwin equations at each step. It relies on the kinematical model for Bragg reflection (with parameters adjusted to reproduce experimental data). For computation of thermal effects (the Debye-Waller factor and coherent inelastic scattering), an expansion of the Debye integral as a rapidly converging series of exponential terms is also presented. Any crystal geometry and plane orientation may be treated. The algorithm has been incorporated into the neutron instrument simulation package NISP. (orig.)

  8. Synthesis Study on Transitions in Signal Infrastructure and Control Algorithms for Connected and Automated Transportation

    Energy Technology Data Exchange (ETDEWEB)

    Aziz, H. M. Abdul [Oak Ridge National Lab. (ORNL), Oak Ridge, TN (United States); Wang, Hong [Pacific Northwest National Lab. (PNNL), Richland, WA (United States); Young, Stan [National Renewable Energy Lab. (NREL), Golden, CO (United States); Sperling, Joshua [National Renewable Energy Lab. (NREL), Golden, CO (United States); Beck, John [Idaho National Lab. (INL), Idaho Falls, ID (United States)

    2017-06-01

    Documenting existing state of practice is an initial step in developing future control infrastructure to be co-deployed for heterogeneous mix of connected and automated vehicles with human drivers while leveraging benefits to safety, congestion, and energy. With advances in information technology and extensive deployment of connected and automated vehicle technology anticipated over the coming decades, cities globally are making efforts to plan and prepare for these transitions. CAVs not only offer opportunities to improve transportation systems through enhanced safety and efficient operations of vehicles. There are also significant needs in terms of exploring how best to leverage vehicle-to-vehicle (V2V) technology, vehicle-to-infrastructure (V2I) technology and vehicle-to-everything (V2X) technology. Both Connected Vehicle (CV) and Connected and Automated Vehicle (CAV) paradigms feature bi-directional connectivity and share similar applications in terms of signal control algorithm and infrastructure implementation. The discussion in our synthesis study assumes the CAV/CV context where connectivity exists with or without automated vehicles. Our synthesis study explores the current state of signal control algorithms and infrastructure, reports the completed and newly proposed CV/CAV deployment studies regarding signal control schemes, reviews the deployment costs for CAV/AV signal infrastructure, and concludes with a discussion on the opportunities such as detector free signal control schemes and dynamic performance management for intersections, and challenges such as dependency on market adaptation and the need to build a fault-tolerant signal system deployment in a CAV/CV environment. The study will serve as an initial critical assessment of existing signal control infrastructure (devices, control instruments, and firmware) and control schemes (actuated, adaptive, and coordinated-green wave). Also, the report will help to identify the future needs for the signal

  9. Nonlinear acceleration of transport criticality problems

    International Nuclear Information System (INIS)

    Park, H.; Knoll, D.A.; Newman, C.K.

    2011-01-01

    We present a nonlinear acceleration algorithm for the transport criticality problem. The algorithm combines the well-known nonlinear diffusion acceleration (NDA) with a recently developed, Newton-based, nonlinear criticality acceleration (NCA) algorithm. The algorithm first employs the NDA to reduce the system to scalar flux, then the NCA is applied to the resulting drift-diffusion system. We apply a nonlinear elimination technique to eliminate the eigenvalue from the Jacobian matrix. Numerical results show that the algorithm reduces the CPU time a factor of 400 in a very diffusive system, and a factor of 5 in a non-diffusive system. (author)

  10. A Coulomb collision algorithm for weighted particle simulations

    Science.gov (United States)

    Miller, Ronald H.; Combi, Michael R.

    1994-01-01

    A binary Coulomb collision algorithm is developed for weighted particle simulations employing Monte Carlo techniques. Charged particles within a given spatial grid cell are pair-wise scattered, explicitly conserving momentum and implicitly conserving energy. A similar algorithm developed by Takizuka and Abe (1977) conserves momentum and energy provided the particles are unweighted (each particle representing equal fractions of the total particle density). If applied as is to simulations incorporating weighted particles, the plasma temperatures equilibrate to an incorrect temperature, as compared to theory. Using the appropriate pairing statistics, a Coulomb collision algorithm is developed for weighted particles. The algorithm conserves energy and momentum and produces the appropriate relaxation time scales as compared to theoretical predictions. Such an algorithm is necessary for future work studying self-consistent multi-species kinetic transport.

  11. Modeling of carrier transport in multi-quantum-well p-i-n modulators

    DEFF Research Database (Denmark)

    Højfeldt, Sune; Mørk, Jesper

    2002-01-01

    The dynamical properties of InGaAsP multi-quantum-well electroabsorption modulators are investigated using a comprehensive numerical device model. We calculate the time-dependent sweep-out of photo-generated carriers and the corresponding time-dependent absorption change. The sweep-out is influen......The dynamical properties of InGaAsP multi-quantum-well electroabsorption modulators are investigated using a comprehensive numerical device model. We calculate the time-dependent sweep-out of photo-generated carriers and the corresponding time-dependent absorption change. The sweep......-out is influenced by carriers being recaptured into subsequent wells as they move towards the contacts. This process drastically increases the sweep-out time in our ten-well structure (similar to25 ps) compared to the pure drift-time (similar to1 ps). We also compare the saturation properties of two components...

  12. An evolutionary algorithm for order splitting with multiple transport alternatives

    NARCIS (Netherlands)

    Dullaert, Wout; Maes, Bart; Vernimmen, Bert; Witlox, Frank

    In this paper, a new methodology is suggested for determining the optimal mix of transport alternatives to minimize total logistics costs when goods are shipped from a supplier to a receiver. The total logistics costs comprise order costs, transportation costs and inventory costs. It is assumed that

  13. Scalable Domain Decomposed Monte Carlo Particle Transport

    Energy Technology Data Exchange (ETDEWEB)

    O' Brien, Matthew Joseph [Univ. of California, Davis, CA (United States)

    2013-12-05

    In this dissertation, we present the parallel algorithms necessary to run domain decomposed Monte Carlo particle transport on large numbers of processors (millions of processors). Previous algorithms were not scalable, and the parallel overhead became more computationally costly than the numerical simulation.

  14. EQUATIONS OF RADIATION TRANSFER IN INFRARED TOMOGRAPHY IN THE CASE OF ACTIVE-PASSIVE DIAGNOSIS AND SWEEPING SCANNING

    Directory of Open Access Journals (Sweden)

    A. A. Makarova

    2014-01-01

    Full Text Available Sweeping scanning scheme of a hot gas in the task of infrared tomography is formulated. Two diagnosis regimes are used: the active one (ON – with included source and the passive one (OFF – without it. Two integral equations are deduced concerning the absorption coefficient k and the Planck function B of a medium (by which it is possible to calculate the temperature profile of a medium T.

  15. Interactions between oxygen permeation and homogeneous-phase fuel conversion on the sweep side of an ion transport membrane

    KAUST Repository

    Hong, Jongsup; Kirchen, Patrick; Ghoniem, Ahmed F.

    2013-01-01

    concentration enhances oxygen permeation substantially. This is accomplished through promoting oxidation reactions (oxygen consumption) and the transport of the products and reaction heat towards the membrane, which lowers the oxygen concentration and increases

  16. A class-chest for deriving transport protocols

    Energy Technology Data Exchange (ETDEWEB)

    Strayer, W.T.

    1996-10-01

    Development of new transport protocols or protocol algorithms suffers from the complexity of the environment in which they are intended to run. Modeling techniques attempt to avoid this by simulating the environment. Another approach to promoting rapid prototyping of protocols and protocol algorithms is to provide a pre-built infrastructure that is common to transport protocols, so that the focus is placed on the protocol-specific aspects. The Meta-Transport Library is a library of C++ base classes that implement or abstract out the mundane functions of a protocol, new protocol implementations are derived from base classes. The result is a fully viable user- level transport protocol implementation, with emphasis on modularity. The collection of base classes form a ``class-chest`` of tools .from which protocols can be developed and studied with as little change to a normal UNIX environment as possible.

  17. A new method for data assimilation: the back and forth nudging algorithm

    OpenAIRE

    Auroux , Didier; Blum , Jacques; Nodet , Maëlle

    2013-01-01

    International audience; In this paper, we propose an improvement to the Back and Forth Nudging algorithm for handling diffusion in the context of geophysical data assimilation. We detail the Diffusive Back and Forth Nudging algorithm, in which the sign of the diffusion term is changed in the backward integrations. We study the convergence of this algorithm, in particular for linear transport equations.

  18. Hybrid Algorithms for Fuzzy Reverse Supply Chain Network Design

    Science.gov (United States)

    Che, Z. H.; Chiang, Tzu-An; Kuo, Y. C.

    2014-01-01

    In consideration of capacity constraints, fuzzy defect ratio, and fuzzy transport loss ratio, this paper attempted to establish an optimized decision model for production planning and distribution of a multiphase, multiproduct reverse supply chain, which addresses defects returned to original manufacturers, and in addition, develops hybrid algorithms such as Particle Swarm Optimization-Genetic Algorithm (PSO-GA), Genetic Algorithm-Simulated Annealing (GA-SA), and Particle Swarm Optimization-Simulated Annealing (PSO-SA) for solving the optimized model. During a case study of a multi-phase, multi-product reverse supply chain network, this paper explained the suitability of the optimized decision model and the applicability of the algorithms. Finally, the hybrid algorithms showed excellent solving capability when compared with original GA and PSO methods. PMID:24892057

  19. Generation of constant-amplitude radio-frequency sweeps at a tunnel junction for spin resonance STM

    International Nuclear Information System (INIS)

    Paul, William; Lutz, Christopher P.; Heinrich, Andreas J.; Baumann, Susanne

    2016-01-01

    We describe the measurement and successful compensation of the radio-frequency transfer function of a scanning tunneling microscope over a wide frequency range (15.5–35.5 GHz) and with high dynamic range (>50 dB). The precise compensation of cabling resonances and attenuations is critical for the production of constant-voltage frequency sweeps for electric-field driven electron spin resonance (ESR) experiments. We also demonstrate that a well-calibrated tunnel junction voltage is necessary to avoid spurious ESR peaks that can arise due to a non-flat transfer function.

  20. Generation of constant-amplitude radio-frequency sweeps at a tunnel junction for spin resonance STM

    Energy Technology Data Exchange (ETDEWEB)

    Paul, William; Lutz, Christopher P.; Heinrich, Andreas J. [IBM Research Division, Almaden Research Center, 650 Harry Road, San Jose, California 95120 (United States); Baumann, Susanne [IBM Research Division, Almaden Research Center, 650 Harry Road, San Jose, California 95120 (United States); Department of Physics, University of Basel, Klingelbergstrasse 82, CH-4056 Basel (Switzerland)

    2016-07-15

    We describe the measurement and successful compensation of the radio-frequency transfer function of a scanning tunneling microscope over a wide frequency range (15.5–35.5 GHz) and with high dynamic range (>50 dB). The precise compensation of cabling resonances and attenuations is critical for the production of constant-voltage frequency sweeps for electric-field driven electron spin resonance (ESR) experiments. We also demonstrate that a well-calibrated tunnel junction voltage is necessary to avoid spurious ESR peaks that can arise due to a non-flat transfer function.

  1. Adaptive integral equation methods in transport theory

    International Nuclear Information System (INIS)

    Kelley, C.T.

    1992-01-01

    In this paper, an adaptive multilevel algorithm for integral equations is described that has been developed with the Chandrasekhar H equation and its generalizations in mind. The algorithm maintains good performance when the Frechet derivative of the nonlinear map is singular at the solution, as happens in radiative transfer with conservative scattering and in critical neutron transport. Numerical examples that demonstrate the algorithm's effectiveness are presented

  2. Unsteady Flow Simulation of a Sweeping Jet Actuator Using a Lattice-Boltzmann Method

    Science.gov (United States)

    Duda, B.; Wessels, M.; Fares, E.; Vatsa, V.

    2016-01-01

    Active flow control technology is increasingly used in aerospace applications to control flow separation and to improve aerodynamic performance. In this paper, PowerFLOW is used to simulate the flow through a sweeping jet actuator at two different pressure ratios. The lower pressure ratio leads to a high subsonic flow, whereas the high pressure ratio produces a choked flow condition. Comparison of numerical results with experimental data is shown, which includes qualitatively good agreement of pressure histories and spectra. PIV measurements are also available but the simulation overestimates mean and fluctuation quantities outside the actuator. If supply pressure is matched at one point inside the mixing chamber a good qualitative agreement is achieved at all other monitor points.

  3. MICADO: Parallel implementation of a 2D-1D iterative algorithm for the 3D neutron transport problem in prismatic geometries

    International Nuclear Information System (INIS)

    Fevotte, F.; Lathuiliere, B.

    2013-01-01

    The large increase in computing power over the past few years now makes it possible to consider developing 3D full-core heterogeneous deterministic neutron transport solvers for reference calculations. Among all approaches presented in the literature, the method first introduced in [1] seems very promising. It consists in iterating over resolutions of 2D and ID MOC problems by taking advantage of prismatic geometries without introducing approximations of a low order operator such as diffusion. However, before developing a solver with all industrial options at EDF, several points needed to be clarified. In this work, we first prove the convergence of this iterative process, under some assumptions. We then present our high-performance, parallel implementation of this algorithm in the MICADO solver. Benchmarking the solver against the Takeda case shows that the 2D-1D coupling algorithm does not seem to affect the spatial convergence order of the MOC solver. As for performance issues, our study shows that even though the data distribution is suited to the 2D solver part, the efficiency of the ID part is sufficient to ensure a good parallel efficiency of the global algorithm. After this study, the main remaining difficulty implementation-wise is about the memory requirement of a vector used for initialization. An efficient acceleration operator will also need to be developed. (authors)

  4. A nonlinear relaxation/quasi-Newton algorithm for the compressible Navier-Stokes equations

    Science.gov (United States)

    Edwards, Jack R.; Mcrae, D. S.

    1992-01-01

    A highly efficient implicit method for the computation of steady, two-dimensional compressible Navier-Stokes flowfields is presented. The discretization of the governing equations is hybrid in nature, with flux-vector splitting utilized in the streamwise direction and central differences with flux-limited artificial dissipation used for the transverse fluxes. Line Jacobi relaxation is used to provide a suitable initial guess for a new nonlinear iteration strategy based on line Gauss-Seidel sweeps. The applicability of quasi-Newton methods as convergence accelerators for this and other line relaxation algorithms is discussed, and efficient implementations of such techniques are presented. Convergence histories and comparisons with experimental data are presented for supersonic flow over a flat plate and for several high-speed compression corner interactions. Results indicate a marked improvement in computational efficiency over more conventional upwind relaxation strategies, particularly for flowfields containing large pockets of streamwise subsonic flow.

  5. GTV-based prescription in SBRT for lung lesions using advanced dose calculation algorithms

    International Nuclear Information System (INIS)

    Lacornerie, Thomas; Lisbona, Albert; Mirabel, Xavier; Lartigau, Eric; Reynaert, Nick

    2014-01-01

    The aim of current study was to investigate the way dose is prescribed to lung lesions during SBRT using advanced dose calculation algorithms that take into account electron transport (type B algorithms). As type A algorithms do not take into account secondary electron transport, they overestimate the dose to lung lesions. Type B algorithms are more accurate but still no consensus is reached regarding dose prescription. The positive clinical results obtained using type A algorithms should be used as a starting point. In current work a dose-calculation experiment is performed, presenting different prescription methods. Three cases with three different sizes of peripheral lung lesions were planned using three different treatment platforms. For each individual case 60 Gy to the PTV was prescribed using a type A algorithm and the dose distribution was recalculated using a type B algorithm in order to evaluate the impact of the secondary electron transport. Secondly, for each case a type B algorithm was used to prescribe 48 Gy to the PTV, and the resulting doses to the GTV were analyzed. Finally, prescriptions based on specific GTV dose volumes were evaluated. When using a type A algorithm to prescribe the same dose to the PTV, the differences regarding median GTV doses among platforms and cases were always less than 10% of the prescription dose. The prescription to the PTV based on type B algorithms, leads to a more important variability of the median GTV dose among cases and among platforms, (respectively 24%, and 28%). However, when 54 Gy was prescribed as median GTV dose, using a type B algorithm, the variability observed was minimal. Normalizing the prescription dose to the median GTV dose for lung lesions avoids variability among different cases and treatment platforms of SBRT when type B algorithms are used to calculate the dose. The combination of using a type A algorithm to optimize a homogeneous dose in the PTV and using a type B algorithm to prescribe the

  6. A Novel Radiation Transport Algorithm for Radiography Simulations

    International Nuclear Information System (INIS)

    Inanc, Feyzi

    2004-01-01

    The simulations used in the NDE community are becoming more realistic with the introduction of more physics. In this work, we have developed a new algorithm that is capable of representing photon and charged particle fluxes through spherical harmonic expansions in a manner similar to well known discrete ordinates method with the exception that Boltzmann operator is treated through exact integration rather than conventional Legendre expansions. This approach provides a mean to include radiation interactions for higher energy regimes where there are additional physical mechanisms for photons and charged particles

  7. Infrastructure system restoration planning using evolutionary algorithms

    Science.gov (United States)

    Corns, Steven; Long, Suzanna K.; Shoberg, Thomas G.

    2016-01-01

    This paper presents an evolutionary algorithm to address restoration issues for supply chain interdependent critical infrastructure. Rapid restoration of infrastructure after a large-scale disaster is necessary to sustaining a nation's economy and security, but such long-term restoration has not been investigated as thoroughly as initial rescue and recovery efforts. A model of the Greater Saint Louis Missouri area was created and a disaster scenario simulated. An evolutionary algorithm is used to determine the order in which the bridges should be repaired based on indirect costs. Solutions were evaluated based on the reduction of indirect costs and the restoration of transportation capacity. When compared to a greedy algorithm, the evolutionary algorithm solution reduced indirect costs by approximately 12.4% by restoring automotive travel routes for workers and re-establishing the flow of commodities across the three rivers in the Saint Louis area.

  8. Research on crude oil storage and transportation based on optimization algorithm

    Science.gov (United States)

    Yuan, Xuhua

    2018-04-01

    At present, the optimization theory and method have been widely used in the optimization scheduling and optimal operation scheme of complex production systems. Based on C++Builder 6 program development platform, the theoretical research results are implemented by computer. The simulation and intelligent decision system of crude oil storage and transportation inventory scheduling are designed. The system includes modules of project management, data management, graphics processing, simulation of oil depot operation scheme. It can realize the optimization of the scheduling scheme of crude oil storage and transportation system. A multi-point temperature measuring system for monitoring the temperature field of floating roof oil storage tank is developed. The results show that by optimizing operating parameters such as tank operating mode and temperature, the total transportation scheduling costs of the storage and transportation system can be reduced by 9.1%. Therefore, this method can realize safe and stable operation of crude oil storage and transportation system.

  9. Sub-Transport Layer Coding

    DEFF Research Database (Denmark)

    Hansen, Jonas; Krigslund, Jeppe; Roetter, Daniel Enrique Lucani

    2014-01-01

    Packet losses in wireless networks dramatically curbs the performance of TCP. This paper introduces a simple coding shim that aids IP-layer traffic in lossy environments while being transparent to transport layer protocols. The proposed coding approach enables erasure correction while being...... oblivious to the congestion control algorithms of the utilised transport layer protocol. Although our coding shim is indifferent towards the transport layer protocol, we focus on the performance of TCP when ran on top of our proposed coding mechanism due to its widespread use. The coding shim provides gains...

  10. The numerical parallel computing of photon transport

    International Nuclear Information System (INIS)

    Huang Qingnan; Liang Xiaoguang; Zhang Lifa

    1998-12-01

    The parallel computing of photon transport is investigated, the parallel algorithm and the parallelization of programs on parallel computers both with shared memory and with distributed memory are discussed. By analyzing the inherent law of the mathematics and physics model of photon transport according to the structure feature of parallel computers, using the strategy of 'to divide and conquer', adjusting the algorithm structure of the program, dissolving the data relationship, finding parallel liable ingredients and creating large grain parallel subtasks, the sequential computing of photon transport into is efficiently transformed into parallel and vector computing. The program was run on various HP parallel computers such as the HY-1 (PVP), the Challenge (SMP) and the YH-3 (MPP) and very good parallel speedup has been gotten

  11. Hybrid shared/distributed parallelism for 3D characteristics transport solvers

    International Nuclear Information System (INIS)

    Dahmani, M.; Roy, R.

    2005-01-01

    In this paper, we will present a new hybrid parallel model for solving large-scale 3-dimensional neutron transport problems used in nuclear reactor simulations. Large heterogeneous reactor problems, like the ones that occurs when simulating Candu cores, have remained computationally intensive and impractical for routine applications on single-node or even vector computers. Based on the characteristics method, this new model is designed to solve the transport equation after distributing the calculation load on a network of shared memory multi-processors. The tracks are either generated on the fly at each characteristics sweep or stored in sequential files. The load balancing is taken into account by estimating the calculation load of tracks and by distributing batches of uniform load on each node of the network. Moreover, the communication overhead can be predicted after benchmarking the latency and bandwidth using appropriate network test suite. These models are useful for predicting the performance of the parallel applications and to analyze the scalability of the parallel systems. (authors)

  12. Verification and improvement of predictive algorithms for radionuclide migration

    International Nuclear Information System (INIS)

    Carnahan, C.L.; Miller, C.W.; Remer, J.S.

    1984-01-01

    This research addresses issues relevant to numerical simulation and prediction of migration of radionuclides in the environment of nuclear waste repositories. Specific issues investigated are the adequacy of current numerical codes in simulating geochemical interactions affecting radionuclide migration, the level of complexity required in chemical algorithms of transport models, and the validity of the constant-k/sub D/ concept in chemical transport modeling. An initial survey of the literature led to the conclusion that existing numerical codes did not encompass the full range of chemical and physical phenomena influential in radionuclide migration. Studies of chemical algorithms have been conducted within the framework of a one-dimensional numerical code that simulates the transport of chemically reacting solutes in a saturated porous medium. The code treats transport by dispersion/diffusion and advection, and equilibrium-controlled proceses of interphase mass transfer, complexation in the aqueous phase, pH variation, and precipitation/dissolution of secondary solids. Irreversible, time-dependent dissolution of solid phases during transport can be treated. Mass action, transport, and sorptive site constraint equations are expressed in differential/algebraic form and are solved simultaneously. Simulations using the code show that use of the constant-k/sub D/ concept can produce unreliable results in geochemical transport modeling. Applications to a field test and laboratory analogs of a nuclear waste repository indicate that a thermodynamically based simulator of chemical transport can successfully mimic real processes provided that operative chemical mechanisms and associated data have been correctly identified and measured, and have been incorporated in the simulator. 17 references, 10 figures

  13. Numerical methods: Analytical benchmarking in transport theory

    International Nuclear Information System (INIS)

    Ganapol, B.D.

    1988-01-01

    Numerical methods applied to reactor technology have reached a high degree of maturity. Certainly one- and two-dimensional neutron transport calculations have become routine, with several programs available on personal computer and the most widely used programs adapted to workstation and minicomputer computational environments. With the introduction of massive parallelism and as experience with multitasking increases, even more improvement in the development of transport algorithms can be expected. Benchmarking an algorithm is usually not a very pleasant experience for the code developer. Proper algorithmic verification by benchmarking involves the following considerations: (1) conservation of particles, (2) confirmation of intuitive physical behavior, and (3) reproduction of analytical benchmark results. By using today's computational advantages, new basic numerical methods have been developed that allow a wider class of benchmark problems to be considered

  14. Oxygen Transport Membrane Reactors for Oxy-Fuel Combustion and Carbon Capture Purposes

    Science.gov (United States)

    Falkenstein-Smith, Ryan L.

    This thesis investigates oxygen transport membrane reactors (OTMs) for the application of oxy-fuel combustion. This is done by evaluating the material properties and oxygen permeability of different OTM compositions subjected to a variety of operating conditions. The scope of this work consists of three components: (1) evaluate the oxygen permeation capabilities of perovskite-type materials for the application of oxy-fuel combustion; (2) determine the effects of dual-phase membrane compositions on the oxygen permeation performance and membrane characteristics; and (3) develop a new method for estimating the oxygen permeation performance of OTMs utilized for the application of oxy-fuel combustion. SrSc0.1Co0.9O3-delta (SSC) is selected as the primary perovskite-type material used in this research due to its reported high ionic and electronic conductive properties and chemical stability. SSC's oxygen ion diffusivity is investigated using a conductivity relaxation technique and thermogravimetric analysis. Material properties such as chemical structure, morphology, and ionic and electronic conductivity are examined by X-ray diffraction (XRD), Scanning Electron Microscope (SEM), and conductivity testing using a four-probe method, respectively. Oxygen permeation tests study the oxygen permeability OTMs under modified membrane temperatures, sweeping gas flow rates, sweeping gas compositions, membrane configurations, and membrane compositions. When utilizing a pure CO2 sweeping gas, the membrane composition was modified with the addition of Sm0.2Ce0.8O1.9-delta (SDC) at varying wt.% to improve the membranes mechanical stability. A newly developed method to evaluate the oxygen permeation performance of OTMs is also presented by fitting OTM's oxygen permeability to the methane fraction in the sweeping gas composition. The fitted data is used to estimate the overall performance and size of OTMs utilized for the application of oxy-fuel combustion. The findings from this

  15. Implementation of a Monte Carlo algorithm for neutron transport on a massively parallel SIMD machine

    International Nuclear Information System (INIS)

    Baker, R.S.

    1992-01-01

    We present some results from the recent adaptation of a vectorized Monte Carlo algorithm to a massively parallel architecture. The performance of the algorithm on a single processor Cray Y-MP and a Thinking Machine Corporations CM-2 and CM-200 is compared for several test problems. The results show that significant speedups are obtainable for vectorized Monte Carlo algorithms on massively parallel machines, even when the algorithms are applied to realistic problems which require extensive variance reduction. However, the architecture of the Connection Machine does place some limitations on the regime in which the Monte Carlo algorithm may be expected to perform well

  16. Implementation of a Monte Carlo algorithm for neutron transport on a massively parallel SIMD machine

    International Nuclear Information System (INIS)

    Baker, R.S.

    1993-01-01

    We present some results from the recent adaptation of a vectorized Monte Carlo algorithm to a massively parallel architecture. The performance of the algorithm on a single processor Cray Y-MP and a Thinking Machine Corporations CM-2 and CM-200 is compared for several test problems. The results show that significant speedups are obtainable for vectorized Monte Carlo algorithms on massively parallel machines, even when the algorithms are applied to realistic problems which require extensive variance reduction. However, the architecture of the Connection Machine does place some limitations on the regime in which the Monte Carlo algorithm may be expected to perform well. (orig.)

  17. Adaptive discrete-ordinates algorithms and strategies

    International Nuclear Information System (INIS)

    Stone, J.C.; Adams, M.L.

    2005-01-01

    We present our latest algorithms and strategies for adaptively refined discrete-ordinates quadrature sets. In our basic strategy, which we apply here in two-dimensional Cartesian geometry, the spatial domain is divided into regions. Each region has its own quadrature set, which is adapted to the region's angular flux. Our algorithms add a 'test' direction to the quadrature set if the angular flux calculated at that direction differs by more than a user-specified tolerance from the angular flux interpolated from other directions. Different algorithms have different prescriptions for the method of interpolation and/or choice of test directions and/or prescriptions for quadrature weights. We discuss three different algorithms of different interpolation orders. We demonstrate through numerical results that each algorithm is capable of generating solutions with negligible angular discretization error. This includes elimination of ray effects. We demonstrate that all of our algorithms achieve a given level of error with far fewer unknowns than does a standard quadrature set applied to an entire problem. To address a potential issue with other algorithms, we present one algorithm that retains exact integration of high-order spherical-harmonics functions, no matter how much local refinement takes place. To address another potential issue, we demonstrate that all of our methods conserve partial currents across interfaces where quadrature sets change. We conclude that our approach is extremely promising for solving the long-standing problem of angular discretization error in multidimensional transport problems. (authors)

  18. Linear programming algorithms and applications

    CERN Document Server

    Vajda, S

    1981-01-01

    This text is based on a course of about 16 hours lectures to students of mathematics, statistics, and/or operational research. It is intended to introduce readers to the very wide range of applicability of linear programming, covering problems of manage­ ment, administration, transportation and a number of other uses which are mentioned in their context. The emphasis is on numerical algorithms, which are illustrated by examples of such modest size that the solutions can be obtained using pen and paper. It is clear that these methods, if applied to larger problems, can also be carried out on automatic (electronic) computers. Commercially available computer packages are, in fact, mainly based on algorithms explained in this book. The author is convinced that the user of these algorithms ought to be knowledgeable about the underlying theory. Therefore this volume is not merely addressed to the practitioner, but also to the mathematician who is interested in relatively new developments in algebraic theory and in...

  19. WASTES: Waste System Transportation and Economic Simulation--Version 2:

    International Nuclear Information System (INIS)

    Sovers, R.A.; Shay, M.R.; Ouderkirk, S.J.; McNair, G.W.; Eagle, B.G.

    1988-02-01

    The Waste System Transportation and Economic Simulation (WASTES) Technical Reference Manual was written to describe and document the algorithms used within the WASTES model as implemented in Version 2.23. The manual will serve as a reference for users of the WASTES system. The intended audience for this manual are knowledgeable users of WASTES who have an interest in the underlying principles and algorithms used within the WASTES model. Each algorithm is described in nonprogrammers terminology, and the source and uncertainties of the constants in use by these algorithms are described. The manual also describes the general philosophy and rules used to: 1) determine the allocation and priority of spent fuel generation sources to facility destinations, 2) calculate transportation costs, and 3) estimate the cost of at-reactor ex-pool storage. A detailed description of the implementation of many of the algorithms is also included in the WASTES Programmers Reference Manual (Shay and Buxbaum 1986a). This manual is separated into sections based on the general usage of the algorithms being discussed. 8 refs., 14 figs., 2 tabs

  20. Research Algorithm on Building Intelligent Transportation System based on RFID Technology

    Directory of Open Access Journals (Sweden)

    Chuanqi Chen

    2013-05-01

    Full Text Available Intelligent transportation system to all aspects of organic integration of human, vehicle, road and environment of the transport system, so that the operation of functional integration and intelligent vehicle, road. Intelligent transportation system (ITS to improve the efficiency of traffic system by increasing the effective use and management of traffic information is mainly composed of information collection and input, output, control strategy, implementation of the subsystems of data transmission and communication subsystem. The RFID reader to wireless communication through the antenna and RFID tag can achieve a write operation on the tag identification codes and memory read data. The paper proposes research on building intelligent transportation system based on RFID technology. Experimental results show that ITS system can effectively improve the traffic situation, improve the utilization rate of the existing road resource and save social cost.

  1. Selective sweep on human amylase genes postdates the split with Neanderthals

    Science.gov (United States)

    Inchley, Charlotte E.; Larbey, Cynthia D. A.; Shwan, Nzar A. A.; Pagani, Luca; Saag, Lauri; Antão, Tiago; Jacobs, Guy; Hudjashov, Georgi; Metspalu, Ene; Mitt, Mario; Eichstaedt, Christina A.; Malyarchuk, Boris; Derenko, Miroslava; Wee, Joseph; Abdullah, Syafiq; Ricaut, François-Xavier; Mormina, Maru; Mägi, Reedik; Villems, Richard; Metspalu, Mait; Jones, Martin K.; Armour, John A. L.; Kivisild, Toomas

    2016-01-01

    Humans have more copies of amylase genes than other primates. It is still poorly understood, however, when the copy number expansion occurred and whether its spread was enhanced by selection. Here we assess amylase copy numbers in a global sample of 480 high coverage genomes and find that regions flanking the amylase locus show notable depression of genetic diversity both in African and non-African populations. Analysis of genetic variation in these regions supports the model of an early selective sweep in the human lineage after the split of humans from Neanderthals which led to the fixation of multiple copies of AMY1 in place of a single copy. We find evidence of multiple secondary losses of copy number with the highest frequency (52%) of a deletion of AMY2A and associated low copy number of AMY1 in Northeast Siberian populations whose diet has been low in starch content. PMID:27853181

  2. Simulation analysis of dust-particle transport in the peripheral plasma in the Large Helical Device

    International Nuclear Information System (INIS)

    Shoji, Mamoru; Masuzaki, Suguru; Kawamura, Gakushi; Yamada, Hiroshi; Tanaka, Yasunori; Uesugi, Yoshihiko; Pigarov, Alexander Yu.; Smirnov, Roman D.

    2014-01-01

    The function of the peripheral plasma in the Large Helical Device (LHD) on transport of dusts is investigated using a dust transport simulation code (DUSTT) in a non-axisymmetric geometry. The simulation shows that the transport of the dusts is dominated by the plasma flow (mainly by ion drag force) formed in the peripheral plasma. The trajectories of dusts are investigated in two probable situations: release of spherical iron dusts from the inboard side of the torus, and drop of spherical carbon dusts from a divertor plate installed near an edge of an upper port. The trajectories in these two situations are calculated in various sized dust cases. From a viewpoint of protection of the main plasma from dust penetration, it proves that there are two functions in the LHD peripheral plasma. One is sweeping of dusts by the effect of the plasma flow in the divertor legs, and another one is evaporation/sublimation of dusts by heat load onto the dusts in the ergodic layer. (author)

  3. Final Technical Report Transport Task Force Activities

    International Nuclear Information System (INIS)

    P.W. Terry

    2006-01-01

    The Transport Task Force has functioned as the primary scientific organization in the area of magnetic-fusion confinement and transport since its inception in 1988. It has defined and set research directions, coordinated broad research efforts, advocated new funding initiatives, and created a highly successful and widely admired interactive culture between experiment, theory and modeling. The Transport Task Force carries out its activities under the direction of its chair and the Executive Committee. The Executive Committee is comprised of the leaders and deputy leaders of the scientific working groups. The working groups are structured and organized according to research needs and priorities and have been organized around the areas of Core Transport, H Mode and Pedestal, Fast Particle Transport, Transient Transport Phenomena, and Modeling and Simulation. A steering committee provides advise on TTF activities. Further information on the working groups and the structure and management of the TTF can be found at http://psfcwww2.psfc.mit.edu/ttf/index.html. The TTF holds an annual workshop. A summary of the workshops held during the period of this report is given in Appendix I. During the period of this report the Transport Task Force was involved in several significant activities. Foremost of these was a sweeping review of the status of transport science, the key research tasks for progress during the next 5-10 years, and a proposal for a funding initiative to ensure application of adequate resources to these problems. The conclusions of this study were incorporated into a white paper, which is copied below in Appendix II. Other significant activities have included the introduction of an extended, ongoing discussion on verification and validation as a requisite for defining and codifying the path toward predictive capability, the orchestration of a gradual shift of focus from ion thermal confinement to electron thermal confinement, and a joining of efforts on edge

  4. Comparison of preconditioned generalized conjugate gradient methods to two-dimensional neutron and photon transport equation

    International Nuclear Information System (INIS)

    Chen, G.S.

    1997-01-01

    We apply and compare the preconditioned generalized conjugate gradient methods to solve the linear system equation that arises in the two-dimensional neutron and photon transport equation in this paper. Several subroutines are developed on the basis of preconditioned generalized conjugate gradient methods for time-independent, two-dimensional neutron and photon transport equation in the transport theory. These generalized conjugate gradient methods are used. TFQMR (transpose free quasi-minimal residual algorithm), CGS (conjuage gradient square algorithm), Bi-CGSTAB (bi-conjugate gradient stabilized algorithm) and QMRCGSTAB (quasi-minimal residual variant of bi-conjugate gradient stabilized algorithm). These sub-routines are connected to computer program DORT. Several problems are tested on a personal computer with Intel Pentium CPU. (author)

  5. Selective epidemic vaccination under the performant routing algorithms

    Science.gov (United States)

    Bamaarouf, O.; Alweimine, A. Ould Baba; Rachadi, A.; EZ-Zahraouy, H.

    2018-04-01

    Despite the extensive research on traffic dynamics and epidemic spreading, the effect of the routing algorithms strategies on the traffic-driven epidemic spreading has not received an adequate attention. It is well known that more performant routing algorithm strategies are used to overcome the congestion problem. However, our main result shows unexpectedly that these algorithms favor the virus spreading more than the case where the shortest path based algorithm is used. In this work, we studied the virus spreading in a complex network using the efficient path and the global dynamic routing algorithms as compared to shortest path strategy. Some previous studies have tried to modify the routing rules to limit the virus spreading, but at the expense of reducing the traffic transport efficiency. This work proposed a solution to overcome this drawback by using a selective vaccination procedure instead of a random vaccination used often in the literature. We found that the selective vaccination succeeded in eradicating the virus better than a pure random intervention for the performant routing algorithm strategies.

  6. Study on Multi-Depot Collaborative Transportation Problem of Milk-Run Pattern

    Directory of Open Access Journals (Sweden)

    Lou Zhenkai

    2016-01-01

    Full Text Available Analyze the relevance between Milk Run mode and collaborative transportation problem, put forward collaborative transportation problem of multiple-depot on Milk Run mode under the supply and demand separate nodes, consider the value of transport and transport costs, introduce the concept of node - arc flow, by comparing the size of traffic flow determine nodes collection, and then constructed multi-transport model of the problem. Considering one-way pickup and delivery closed, construct two-stage algorithm model, use dynamic programming recursive solution to determine the best route to pick up, and then solving delivery routing problem with different start and return point based on geometric method of Cosine. Finally use a numerical example illustrates the effectiveness of the algorithm and reasonable model.

  7. A theoretical derivation of the condensed history algorithm

    International Nuclear Information System (INIS)

    Larsen, E.W.

    1992-01-01

    Although the Condensed History Algorithm is a successful and widely-used Monte Carlo method for solving electron transport problems, it has been derived only by an ad-hoc process based on physical reasoning. In this paper we show that the Condensed History Algorithm can be justified as a Monte Carlo simulation of an operator-split procedure in which the streaming, angular scattering, and slowing-down operators are separated within each time step. Different versions of the operator-split procedure lead to Ο(Δs) and Ο(Δs 2 ) versions of the method, where Δs is the path-length step. Our derivation also indicates that higher-order versions of the Condensed History Algorithm may be developed. (Author)

  8. New nonlinear methods for linear transport calculations

    International Nuclear Information System (INIS)

    Adams, M.L.

    1993-01-01

    We present a new family of methods for the numerical solution of the linear transport equation. With these methods an iteration consists of an 'S N sweep' followed by an 'S 2 -like' calculation. We show, by analysis as well as numerical results, that iterative convergence is always rapid. We show that this rapid convergence does not depend on a consistent discretization of the S 2 -like equations - they can be discretized independently from the S N equations. We show further that independent discretizations can offer significant advantages over consistent ones. In particular, we find that in a wide range of problems, an accurate discretization of the S 2 -like equation can be combined with a crude discretization of the S N equations to produce an accurate S N answer. We demonstrate this by analysis as well as numerical results. (orig.)

  9. Solution of single linear tridiagonal systems and vectorization of the ICCG algorithm on the Cray 1

    International Nuclear Information System (INIS)

    Kershaw, D.S.

    1981-01-01

    The numerical algorithms used to solve the physics equation in codes which model laser fusion are examined, it is found that a large number of subroutines require the solution of tridiagonal linear systems of equations. One dimensional radiation transport, thermal and suprathermal electron transport, ion thermal conduction, charged particle and neutron transport, all require the solution of tridiagonal systems of equations. The standard algorithm that has been used in the past on CDC 7600's will not vectorize and so cannot take advantage of the large speed increases possible on the Cray-1 through vectorization. There is however, an alternate algorithm for solving tridiagonal systems, called cyclic reduction, which allows for vectorization, and which is optimal for the Cray-1. Software based on this algorithm is now being used in LASNEX to solve tridiagonal linear systems in the subroutines mentioned above. The new algorithm runs as much as five times faster than the standard algorithm on the Cray-1. The ICCG method is being used to solve the diffusion equation with a nine-point coupling scheme on the CDC 7600. In going from the CDC 7600 to the Cray-1, a large part of the algorithm consists of solving tridiagonal linear systems on each L line of the Lagrangian mesh in a manner which is not vectorizable. An alternate ICCG algorithm for the Cray-1 was developed which utilizes a block form of the cyclic reduction algorithm. This new algorithm allows full vectorization and runs as much as five times faster than the old algorithm on the Cray-1. It is now being used in Cray LASNEX to solve the two-dimensional diffusion equation in all the physics subroutines mentioned above

  10. Magnetic Shear and Transport in ECRH Discharges of the TJ-II under Ohmic Induction

    Energy Technology Data Exchange (ETDEWEB)

    Lopez-Bruna, D.; Castejon, F.; Romero, J. A.; Estrada, T.; Medina, F.; Ochando, M.; Lopez-Fraguas, A.; Ascasibar, E.; Herranz, J.; Sanchez, E.; Luna, E. de la; Pastor, I.

    2006-07-01

    TJ-II is ha heliac type stellarator characterised by high, but almost constant, vacuum rotational transform throughout the confining volume. In ECRH plasmas, moderate induced ohmic currents (negligible heating and modification of the magnetic field nodules) are enough to disregard the bootstrap contribution, which allows us performing a fair calculation of the evolution of the rotational transform. We use the loop voltage diagnostic to estimate the plasma electrical conductivity. Then the evolution of the rotational transform and shear is related to changes in the profiles of electron and thermal diffusivities: negative shear correlates with decreasing diffusivities in the region of steepest density gradient; transport increases toward zero shear but the achieved positive values are too small to draw conclusions. The radial sweeping of lowest order rational magnetic surfaces does not determine the observed trends in transport. (Author)43 refs.

  11. Magnetic Shear and Transport in ECRH Discharges of the TJ-II under Ohmic Induction

    International Nuclear Information System (INIS)

    Lopez-Bruna, D.; Castejon, F.; Romero, J. A.; Estrada, T.; Medina, F.; Ochando, M.; Lopez-Fraguas, A.; Ascasibar, E.; Herranz, J.; Sanchez, E.; Luna, E. de la; Pastor, I.

    2006-01-01

    TJ-II is ha heliac type stellarator characterised by high, but almost constant, vacuum rotational transform throughout the confining volume. In ECRH plasmas, moderate induced ohmic currents (negligible heating and modification of the magnetic field nodules) are enough to disregard the bootstrap contribution, which allows us performing a fair calculation of the evolution of the rotational transform. We use the loop voltage diagnostic to estimate the plasma electrical conductivity. Then the evolution of the rotational transform and shear is related to changes in the profiles of electron and thermal diffusivities: negative shear correlates with decreasing diffusivities in the region of steepest density gradient; transport increases toward zero shear but the achieved positive values are too small to draw conclusions. The radial sweeping of lowest order rational magnetic surfaces does not determine the observed trends in transport. (Author)43 refs

  12. Solving the Dial-a-Ride Problem using Genetic algorithms

    DEFF Research Database (Denmark)

    Bergvinsdottir, Kristin Berg; Larsen, Jesper; Jørgensen, Rene Munk

    In the Dial-a-Ride problem (DARP) customers send transportation requests to an operator. A request consists of a specified pickup location and destination location along with a desired departure or arrival time and demand. The aim of DARP is to minimize transportation cost while satisfying custom...... routing problems for the vehicles using a routing heuristic. The algorithm is implemented in Java and tested on publicly available data sets....

  13. Verification and improvement of predictive algorithms for radionuclide migration

    International Nuclear Information System (INIS)

    Carnahan, C.L.; Miller, C.W.; Remer, J.S.

    1984-01-01

    This research investigated the adequacy of current numerical codes in simulating geochemical interactions affecting radionuclide migration, the level of complexity required in chemical algorithms of transport models, and the validity of the constant-k/sub D/ concept in chemical transport modeling. An initial survey of the literature led to the conclusion that existing numerical codes did not encompass the full range of chemical and physical phenomena influential in radionuclide migration

  14. Transport processes near coastal ocean outfalls

    Science.gov (United States)

    Noble, M.A.; Sherwood, C.R.; Lee, Hooi-Ling; Xu, Jie; Dartnell, P.; Robertson, G.; Martini, M.

    2001-01-01

    The central Southern California Bight is an urbanized coastal ocean where complex topography and largescale atmospheric and oceanographic forcing has led to numerous sediment-distribution patterns. Two large embayments, Santa Monica and San Pedro Bays, are connected by the short, very narrow shelf off the Palos Verdes peninsula. Ocean-sewage outfalls are located in the middle of Santa Monica Bay, on the Palos Verdes shelf and at the southeastern edge of San Pedro Bay. In 1992, the US Geological Survey, together with allied agencies, began a series of programs to determine the dominant processes that transport sediment and associated pollutants near the three ocean outfalls. As part of these programs, arrays of instrumented moorings that monitor currents, waves, water clarity, water density and collect resuspended materials were deployed on the continental shelf and slope information was also collected on the sediment and contaminant distributions in the region. The data and models developed for the Palos Verdes shelf suggest that the large reservoir of DDT/DDE in the coastal ocean sediments will continue to be exhumed and transported along the shelf for a long time. On the Santa Monica shelf, very large internal waves, or bores, are generated at the shelf break. The near-bottom currents associated with these waves sweep sediments and the associated contaminants from the shelf onto the continental slope. A new program underway on the San Pedro shelf will determine if water and contaminants from a nearby ocean outfall are transported to the local beaches by coastal ocean processes. The large variety of processes found that transport sediments and contaminants in this small region of the continental margin suggest that in regions with complex topography, local processes change markedly over small spatial scales. One cannot necessarily infer that the dominant transport processes will be similar even in adjacent regions.

  15. A state-of-the-art review of transportation systems evaluation techniques relevant to air transportation, volume 1. [urban planning and urban transportation using decision theory

    Science.gov (United States)

    Haefner, L. E.

    1975-01-01

    Mathematical and philosophical approaches are presented for evaluation and implementation of ground and air transportation systems. Basic decision processes are examined that are used for cost analyses and planning (i.e, statistical decision theory, linear and dynamic programming, optimization, game theory). The effects on the environment and the community that a transportation system may have are discussed and modelled. Algorithmic structures are examined and selected bibliographic annotations are included. Transportation dynamic models were developed. Citizen participation in transportation projects (i.e, in Maryland and Massachusetts) is discussed. The relevance of the modelling and evaluation approaches to air transportation (i.e, airport planning) is examined in a case study in St. Louis, Missouri.

  16. Combined spatial/angular domain decomposition SN algorithms for shared memory parallel machines

    International Nuclear Information System (INIS)

    Hunter, M.A.; Haghighat, A.

    1993-01-01

    Several parallel processing algorithms on the basis of spatial and angular domain decomposition methods are developed and incorporated into a two-dimensional discrete ordinates transport theory code. These algorithms divide the spatial and angular domains into independent subdomains so that the flux calculations within each subdomain can be processed simultaneously. Two spatial parallel algorithms (Block-Jacobi, red-black), one angular parallel algorithm (η-level), and their combinations are implemented on an eight processor CRAY Y-MP. Parallel performances of the algorithms are measured using a series of fixed source RZ geometry problems. Some of the results are also compared with those executed on an IBM 3090/600J machine. (orig.)

  17. Improved multilayer OLED architecture using evolutionary genetic algorithm

    International Nuclear Information System (INIS)

    Quirino, W.G.; Teixeira, K.C.; Legnani, C.; Calil, V.L.; Messer, B.; Neto, O.P. Vilela; Pacheco, M.A.C.; Cremona, M.

    2009-01-01

    Organic light-emitting diodes (OLEDs) constitute a new class of emissive devices, which present high efficiency and low voltage operation, among other advantages over current technology. Multilayer architecture (M-OLED) is generally used to optimize these devices, specially overcoming the suppression of light emission due to the exciton recombination near the metal layers. However, improvement in recombination, transport and charge injection can also be achieved by blending electron and hole transporting layers into the same one. Graded emissive region devices can provide promising results regarding quantum and power efficiency and brightness, as well. The massive number of possible model configurations, however, suggests that a search algorithm would be more suitable for this matter. In this work, multilayer OLEDs were simulated and fabricated using Genetic Algorithms (GAs) as evolutionary strategy to improve their efficiency. Genetic Algorithms are stochastic algorithms based on genetic inheritance and Darwinian strife to survival. In our simulations, it was assumed a 50 nm width graded region, divided into five equally sized layers. The relative concentrations of the materials within each layer were optimized to obtain the lower V/J 0.5 ratio, where V is the applied voltage and J the current density. The best M-OLED architecture obtained by genetic algorithm presented a V/J 0.5 ratio nearly 7% lower than the value reported in the literature. In order to check the experimental validity of the improved results obtained in the simulations, two M-OLEDs with different architectures were fabricated by thermal deposition in high vacuum environment. The results of the comparison between simulation and some experiments are presented and discussed.

  18. Maintenance measures for preservation and recovery of permeable pavement surface infiltration rate--The effects of street sweeping, vacuum cleaning, high pressure washing, and milling.

    Science.gov (United States)

    Winston, Ryan J; Al-Rubaei, Ahmed M; Blecken, Godecke T; Viklander, Maria; Hunt, William F

    2016-03-15

    The surface infiltration rates (SIR) of permeable pavements decline with time as sediment and debris clog pore spaces. Effective maintenance techniques are needed to ensure the hydraulic functionality and water quality benefits of this stormwater control. Eight different small-scale and full-scale maintenance techniques aimed at recovering pavement permeability were evaluated at ten different permeable pavement sites in the USA and Sweden. Maintenance techniques included manual removal of the upper 2 cm of fill material, mechanical street sweeping, regenerative-air street sweeping, vacuum street sweeping, hand-held vacuuming, high pressure washing, and milling of porous asphalt. The removal of the upper 2 cm of clogging material did not significantly improve the SIR of concrete grid paves (CGP) and permeable interlocking concrete pavers (PICP) due to the inclusion of fines in the joint and bedding stone during construction, suggesting routine maintenance cannot overcome improper construction. For porous asphalt maintenance, industrial hand-held vacuum cleaning, pressure washing, and milling were increasingly successful at recovering the SIR. Milling to a depth of 2.5 cm nearly restored the SIR for a 21-year old porous asphalt pavement to like-new conditions. For PICP, street sweepers employing suction were shown to be preferable to mechanical sweepers; additionally, maintenance efforts may become more intensive over time to maintain a threshold SIR, as maintenance was not 100% effective at removing clogging material. Copyright © 2015 Elsevier Ltd. All rights reserved.

  19. Influence of hydrogen addition to a sweep gas on tritium behavior in a blanket module containing Li{sub 2}TiO{sub 3} pebbles

    Energy Technology Data Exchange (ETDEWEB)

    Katayama, K., E-mail: kadzu@nucl.kyushu-u.ac.jp [Department of Advanced Energy Engineering Science, Kyushu University 6-1, Kasugakoen, Kasuga-shi, Fukuoka 816-8580 (Japan); Someya, Y.; Tobita, K. [National Institutes for Quantum and radiological Science and Technology, 2-166 Omotedate, Obuchi, Rokkasho-mura, Kamikita-gun, Aomori 039-3212 (Japan); Fukada, S. [Department of Advanced Energy Engineering Science, Kyushu University 6-1, Kasugakoen, Kasuga-shi, Fukuoka 816-8580 (Japan); Hatano, Y. [Hydrogen Isotope Research Center, University of Toyama, Gofuku 3190, Toyama 930-8555 (Japan); Chikada, T. [Department of Chemistry, Graduate school of Science, Shizuoka University, 836 Ohya, Suruga-ku, Shizuoka, 422-8529 (Japan)

    2016-12-15

    Highlights: • Mass balance equations of H{sub 2}, H{sub 2}O, T{sub 2} and T{sub 2}O in a Li{sub 2}TiO{sub 3} pebble bed were numerically calculated. • In the temperature rising process, the pebbles were exposed to water vapor of relatively high concentration. • Tritium permeation rate to cooling water reduced with increasing hydrogen concentration in the sweep gas. • Tritium inventory in the grain bulk and the grain surface occupied 99.6% of total inventory. - Abstract: Hydrogen addition to a sweep gas of a solid breeder blanket module has been proposed to enhance tritium recovery from the surface of the breeders. However, the influence of hydrogen addition on the bred tritium behavior is not understood completely. Tritium behavior in the simplified blanket module of Li{sub 2}TiO{sub 3} pebbles was numerically calculated considering diffusion in the grain bulk, surface reactions on the grain surface and permeation through the cooling pipe. Although a partial pressure of T{sub 2} increases with increasing a partial pressure of H{sub 2} in the sweep gas, it was estimated that tritium permeation rate to the cooling water decreases. Additionally, the release duration of water vapor generated by the reaction of the pebbles and hydrogen is shortened with increasing a partial pressure of H{sub 2}. Tritium inventory in the grain bulk and the grain surface occupies 99.6 % of total tritium inventory in the blanket module.

  20. A comparison of MCNP4C electron transport with ITS 3.0 and experiment at incident energies between 100 keV and 20 MeV: influence of voxel size, substeps and energy indexing algorithm

    International Nuclear Information System (INIS)

    Schaart, Dennis R.; Jansen, Jan Th.M.; Zoetelief, Johannes; Leege, Piet F.A. de

    2002-01-01

    The condensed-history electron transport algorithms in the Monte Carlo code MCNP4C are derived from ITS 3.0, which is a well-validated code for coupled electron-photon simulations. This, combined with its user-friendliness and versatility, makes MCNP4C a promising code for medical physics applications. Such applications, however, require a high degree of accuracy. In this work, MCNP4C electron depth-dose distributions in water are compared with published ITS 3.0 results. The influences of voxel size, substeps and choice of electron energy indexing algorithm are investigated at incident energies between 100 keV and 20 MeV. Furthermore, previously published dose measurements for seven beta emitters are simulated. Since MCNP4C does not allow tally segmentation with the *F8 energy deposition tally, even a homogeneous phantom must be subdivided in cells to calculate the distribution of dose. The repeated interruption of the electron tracks at the cell boundaries significantly affects the electron transport. An electron track length estimator of absorbed dose is described which allows tally segmentation. In combination with the ITS electron energy indexing algorithm, this estimator appears to reproduce ITS 3.0 and experimental results well. If, however, cell boundaries are used instead of segments, or if the MCNP indexing algorithm is applied, the agreement is considerably worse. (author)

  1. Algorithms for solving the single-sink fixed-charge transportation problem

    DEFF Research Database (Denmark)

    Klose, Andreas

    2006-01-01

    The single-sink fixed-charge transportation problem is an important subproblem of the fixed-charge transportation problem. Just a few methods have been proposed in the literature to solve this problem. In this paper, solution approaches based on dynamic programming and implicit enumeration...... are revisited. It is shown how the problem size as well as the search space of a recently published dynamic programming method can be reduced by exploiting reduced cost information. Additionally, a further implicit enumeration approach relying on solution concepts for the binary knapsack problem is introduced...

  2. Evaluation on sweep gas pressure drop in fusion blanket mock-up for in-pile test

    International Nuclear Information System (INIS)

    Ishitsuka, Etsuo; Kawamura, Hiroshi; Sagawa, Hisashi; Nagakura, Masaaki; Kanzawa, Toru.

    1993-03-01

    In the ITER/CDA (Conceptual Design Activity) of a tritium breeding blanket, Japan have proposed the pebble-typed blanket. The in-pile mock-up test will be preparing in JMTR (Japan Materials Testing Reactor) for Japanese engineering design with the pebble-typed blanket. Therefore, the He sweep gas pressure drop in the pebble bed was measured for the design of the mock-up used on in-pile test. From the results of this test, it was clear that the pressure drop was predicted on Kozeny- Carman's equation within +25 ∼ -60 %, and that the pressure drop was not affected by moisture concentration (< 100 ppm). (author)

  3. Evaluation on sweep gas pressure drop in fusion blanket mock-up for in-pile test

    Energy Technology Data Exchange (ETDEWEB)

    Ishitsuka, Etsuo; Kawamura, Hiroshi; Sagawa, Hisashi (Japan Atomic Energy Research Inst., Oarai, Ibaraki (Japan). Oarai Research Establishment); Nagakura, Masaaki; Kanzawa, Toru.

    1993-03-01

    In the ITER/CDA (Conceptual Design Activity) of a tritium breeding blanket, Japan have proposed the pebble-typed blanket. The in-pile mock-up test will be preparing in JMTR (Japan Materials Testing Reactor) for Japanese engineering design with the pebble-typed blanket. Therefore, the He sweep gas pressure drop in the pebble bed was measured for the design of the mock-up used on in-pile test. From the results of this test, it was clear that the pressure drop was predicted on Kozeny- Carman's equation within +25 [approx] -60 %, and that the pressure drop was not affected by moisture concentration (< 100 ppm). (author).

  4. Evaluation on sweep gas pressure drop in fusion blanket mock-up for in-pile test

    Energy Technology Data Exchange (ETDEWEB)

    Ishitsuka, Etsuo; Kawamura, Hiroshi; Sagawa, Hisashi [Japan Atomic Energy Research Inst., Oarai, Ibaraki (Japan). Oarai Research Establishment; Nagakura, Masaaki; Kanzawa, Toru

    1993-03-01

    In the ITER/CDA (Conceptual Design Activity) of a tritium breeding blanket, Japan have proposed the pebble-typed blanket. The in-pile mock-up test will be preparing in JMTR (Japan Materials Testing Reactor) for Japanese engineering design with the pebble-typed blanket. Therefore, the He sweep gas pressure drop in the pebble bed was measured for the design of the mock-up used on in-pile test. From the results of this test, it was clear that the pressure drop was predicted on Kozeny- Carman`s equation within +25 {approx} -60 %, and that the pressure drop was not affected by moisture concentration (< 100 ppm). (author).

  5. Bridge health monitoring metrics : updating the bridge deficiency algorithm.

    Science.gov (United States)

    2009-10-01

    As part of its bridge management system, the Alabama Department of Transportation (ALDOT) must decide how best to spend its bridge replacement funds. In making these decisions, ALDOT managers currently use a deficiency algorithm to rank bridges that ...

  6. Dosimetric impact of Acuros XB deterministic radiation transport algorithm for heterogeneous dose calculation in lung cancer

    International Nuclear Information System (INIS)

    Han Tao; Followill, David; Repchak, Roman; Molineu, Andrea; Howell, Rebecca; Salehpour, Mohammad; Mikell, Justin; Mourtada, Firas

    2013-01-01

    Purpose: The novel deterministic radiation transport algorithm, Acuros XB (AXB), has shown great potential for accurate heterogeneous dose calculation. However, the clinical impact between AXB and other currently used algorithms still needs to be elucidated for translation between these algorithms. The purpose of this study was to investigate the impact of AXB for heterogeneous dose calculation in lung cancer for intensity-modulated radiation therapy (IMRT) and volumetric-modulated arc therapy (VMAT). Methods: The thorax phantom from the Radiological Physics Center (RPC) was used for this study. IMRT and VMAT plans were created for the phantom in the Eclipse 11.0 treatment planning system. Each plan was delivered to the phantom three times using a Varian Clinac iX linear accelerator to ensure reproducibility. Thermoluminescent dosimeters (TLDs) and Gafchromic EBT2 film were placed inside the phantom to measure delivered doses. The measurements were compared with dose calculations from AXB 11.0.21 and the anisotropic analytical algorithm (AAA) 11.0.21. Two dose reporting modes of AXB, dose-to-medium in medium (D m,m ) and dose-to-water in medium (D w,m ), were studied. Point doses, dose profiles, and gamma analysis were used to quantify the agreement between measurements and calculations from both AXB and AAA. The computation times for AAA and AXB were also evaluated. Results: For the RPC lung phantom, AAA and AXB dose predictions were found in good agreement to TLD and film measurements for both IMRT and VMAT plans. TLD dose predictions were within 0.4%–4.4% to AXB doses (both D m,m and D w,m ); and within 2.5%–6.4% to AAA doses, respectively. For the film comparisons, the gamma indexes (±3%/3 mm criteria) were 94%, 97%, and 98% for AAA, AXB Dm,m , and AXB Dw,m , respectively. The differences between AXB and AAA in dose–volume histogram mean doses were within 2% in the planning target volume, lung, heart, and within 5% in the spinal cord. However

  7. MC++: A parallel, portable, Monte Carlo neutron transport code in C++

    International Nuclear Information System (INIS)

    Lee, S.R.; Cummings, J.C.; Nolen, S.D.

    1997-01-01

    MC++ is an implicit multi-group Monte Carlo neutron transport code written in C++ and based on the Parallel Object-Oriented Methods and Applications (POOMA) class library. MC++ runs in parallel on and is portable to a wide variety of platforms, including MPPs, SMPs, and clusters of UNIX workstations. MC++ is being developed to provide transport capabilities to the Accelerated Strategic Computing Initiative (ASCI). It is also intended to form the basis of the first transport physics framework (TPF), which is a C++ class library containing appropriate abstractions, objects, and methods for the particle transport problem. The transport problem is briefly described, as well as the current status and algorithms in MC++ for solving the transport equation. The alpha version of the POOMA class library is also discussed, along with the implementation of the transport solution algorithms using POOMA. Finally, a simple test problem is defined and performance and physics results from this problem are discussed on a variety of platforms

  8. Mathematical Model and Algorithm for the Reefer Mechanic Scheduling Problem at Seaports

    Directory of Open Access Journals (Sweden)

    Jiantong Zhang

    2017-01-01

    Full Text Available With the development of seaborne logistics, the international trade of goods transported in refrigerated containers is growing fast. Refrigerated containers, also known as reefers, are used in transportation of temperature sensitive cargo, such as perishable fruits. This trend brings new challenges to terminal managers, that is, how to efficiently arrange mechanics to plug and unplug power for the reefers (i.e., tasks at yards. This work investigates the reefer mechanics scheduling problem at container ports. To minimize the sum of the total tardiness of all tasks and the total working distance of all mechanics, we formulate a mathematical model. For the resolution of this problem, we propose a DE algorithm which is combined with efficient heuristics, local search strategies, and parameter adaption scheme. The proposed algorithm is tested and validated through numerical experiments. Computational results demonstrate the effectiveness and efficiency of the proposed algorithm.

  9. Nonequilibrium molecular dynamics theory, algorithms and applications

    CERN Document Server

    Todd, Billy D

    2017-01-01

    Written by two specialists with over twenty-five years of experience in the field, this valuable text presents a wide range of topics within the growing field of nonequilibrium molecular dynamics (NEMD). It introduces theories which are fundamental to the field - namely, nonequilibrium statistical mechanics and nonequilibrium thermodynamics - and provides state-of-the-art algorithms and advice for designing reliable NEMD code, as well as examining applications for both atomic and molecular fluids. It discusses homogenous and inhomogenous flows and pays considerable attention to highly confined fluids, such as nanofluidics. In addition to statistical mechanics and thermodynamics, the book covers the themes of temperature and thermodynamic fluxes and their computation, the theory and algorithms for homogenous shear and elongational flows, response theory and its applications, heat and mass transport algorithms, applications in molecular rheology, highly confined fluids (nanofluidics), the phenomenon of slip and...

  10. Simulating Linear Sweep Voltammetry from First-Principles: Application to Electrochemical Oxidation of Water on Pt(111) and Pt3Ni(111)

    DEFF Research Database (Denmark)

    Viswanathan, Venkatasubramanian; Hansen, Heine Anton; Rossmeisl, Jan

    2012-01-01

    Cyclic voltammetry is a fundamental experimental method for characterizing adsorbates on electrochemical surfaces. We present a model for the electrochemical solid–liquid interface, and we simulate the linear sweep voltammogram of the electrochemical oxidation of H2O on Pt(111) and Pt3Ni(111...

  11. Flow, transport and diffusion in random geometries I: a MLMC algorithm

    KAUST Repository

    Canuto, Claudio; Hoel, Haakon; Icardi, Matteo; Quadrio, Nathan; Tempone, Raul

    2015-01-01

    -purpose algorithm and computational code for the solution of Partial Differential Equations (PDEs) on random geoemtry and with random parameters. We make use of the key idea of MLMC, based on different discretization levels, extending it in a more general context

  12. On Production and Green Transportation Coordination in a Sustainable Global Supply Chain

    Directory of Open Access Journals (Sweden)

    Feng Guo

    2017-11-01

    Full Text Available This paper addresses a coordination problem of production and green transportation and the effects of production and transportation coordination on supply chain sustainability in a global supply chain environment with the consideration of important realistic characteristics, including parallel machines, different order processing complexities, fixed delivery departure times, green transportation and multiple transportation modes. We formulate the measurements for carbon emissions of different transportation modes, including air, sea and land transportation. A hybrid genetic algorithm-based optimization approach is developed to handle this problem, in which a hybrid genetic algorithm and heuristic procedures are combined. The effectiveness of the proposed approach is validated by means of various problem instances. We observe that the coordination of production and green transportation has a large effect on the overall supply chain sustainability, which can reduce the total supply chain cost by 9.60% to 21.90%.

  13. Second order time evolution of the multigroup diffusion and P1 equations for radiation transport

    International Nuclear Information System (INIS)

    Olson, Gordon L.

    2011-01-01

    Highlights: → An existing multigroup transport algorithm is extended to be second-order in time. → A new algorithm is presented that does not require a grey acceleration solution. → The two algorithms are tested with 2D, multi-material problems. → The two algorithms have comparable computational requirements. - Abstract: An existing solution method for solving the multigroup radiation equations, linear multifrequency-grey acceleration, is here extended to be second order in time. This method works for simple diffusion and for flux-limited diffusion, with or without material conduction. A new method is developed that does not require the solution of an averaged grey transport equation. It is effective solving both the diffusion and P 1 forms of the transport equation. Two dimensional, multi-material test problems are used to compare the solution methods.

  14. I/O-Optimal Distribution Sweeping on Private-Cache Chip Multiprocessors

    DEFF Research Database (Denmark)

    Ajwani, Deepak; Sitchinava, Nodar; Zeh, Norbert

    2011-01-01

    /PB) for a number of problems on axis aligned objects; P denotes the number of cores/processors, B denotes the number of elements that fit in a cache line, N and K denote the sizes of the input and output, respectively, and sortp(N) denotes the I/O complexity of sorting N items using P processors in the PEM model...... framework was introduced recently, and a number of algorithms for problems on axis-aligned objects were obtained using this framework. The obtained algorithms were efficient but not optimal. In this paper, we improve the framework to obtain algorithms with the optimal I/O complexity of O(sortp(N) + K...

  15. High-order accurate numerical algorithm for three-dimensional transport prediction

    Energy Technology Data Exchange (ETDEWEB)

    Pepper, D W [Savannah River Lab., Aiken, SC; Baker, A J

    1980-01-01

    The numerical solution of the three-dimensional pollutant transport equation is obtained with the method of fractional steps; advection is solved by the method of moments and diffusion by cubic splines. Topography and variable mesh spacing are accounted for with coordinate transformations. First estimate wind fields are obtained by interpolation to grid points surrounding specific data locations. Numerical results agree with results obtained from analytical Gaussian plume relations for ideal conditions. The numerical model is used to simulate the transport of tritium released from the Savannah River Plant on 2 May 1974. Predicted ground level air concentration 56 km from the release point is within 38% of the experimentally measured value.

  16. Fitting the elementary rate constants of the P-gp transporter network in the hMDR1-MDCK confluent cell monolayer using a particle swarm algorithm.

    Directory of Open Access Journals (Sweden)

    Deep Agnani

    Full Text Available P-glycoprotein, a human multidrug resistance transporter, has been extensively studied due to its importance to human health and disease. In order to understand transport kinetics via P-gp, confluent cell monolayers overexpressing P-gp are widely used. The purpose of this study is to obtain the mass action elementary rate constants for P-gp's transport and to functionally characterize members of P-gp's network, i.e., other transporters that transport P-gp substrates in hMDR1-MDCKII confluent cell monolayers and are essential to the net substrate flux. Transport of a range of concentrations of amprenavir, loperamide, quinidine and digoxin across the confluent monolayer of cells was measured in both directions, apical to basolateral and basolateral to apical. We developed a global optimization algorithm using the Particle Swarm method that can simultaneously fit all datasets to yield accurate and exhaustive fits of these elementary rate constants. The statistical sensitivity of the fitted values was determined by using 24 identical replicate fits, yielding simple averages and standard deviations for all of the kinetic parameters, including the efflux active P-gp surface density. Digoxin required additional basolateral and apical transporters, while loperamide required just a basolateral tranporter. The data were better fit by assuming bidirectional transporters, rather than active importers, suggesting that they are not MRP or active OATP transporters. The P-gp efflux rate constants for quinidine and digoxin were about 3-fold smaller than reported ATP hydrolysis rate constants from P-gp proteoliposomes. This suggests a roughly 3∶1 stoichiometry between ATP hydrolysis and P-gp transport for these two drugs. The fitted values of the elementary rate constants for these P-gp substrates support the hypotheses that the selective pressures on P-gp are to maintain a broad substrate range and to keep xenobiotics out of the cytosol, but not out of the

  17. NGC 3312: A victim of ram pressure sweeping

    International Nuclear Information System (INIS)

    Mcmahon, P.M.; Richter, O.G.; Vangorkom, J.H.; Ferguson, H.C.

    1990-01-01

    Researchers are undertaking a volume limited survey of the Hydra I cluster in neutral hydrogen using the National Radio Astronomy Observatory's Very Large Array (VLA). The main purpose is to study the effects of a dense environment on the gaseous component of the galaxies. Observational evidence has been accumulating recently that ram pressure sweeping does occur in the centers of clusters, but it is possible that tidal interactions play a role as well. Results of high resolution HI imaging of NGC 3312, the large peculiar spiral near the cluster center are presented. Hydra I (= A1060) is the nearest rich cluster beyond Virgo and, as such, presents a unique opportunity to do a complete survey of a cluster. It is similar to the Virgo cluster in many of its general physical characteristics, such as size, x ray luminosity, velocity dispersion, and galaxy content (high spiral fraction). However, Hydra I appears to be more regular and relaxed. This is evident in the x ray distribution in its central region, which is radially symmetric and centered on the dominant galaxy, NGC 3311, a cD-like elliptical. The observed x ray luminosity implies a central gas density of 4.5 x 10 to the 3rd power cm(-3). Gallagher (1978) argued from optical images of NGC 3312 that this galaxy might be an ideal candidate to directly study effects of the ram pressure process; it might currently be undergoing stripping of its interstellar medium. The researchers' data are consistent with this suggestion, but other origins of the peculiar appearance cannot yet be ruled out

  18. Partially linearized algorithms in gyrokinetic particle simulation

    Energy Technology Data Exchange (ETDEWEB)

    Dimits, A.M.; Lee, W.W.

    1990-10-01

    In this paper, particle simulation algorithms with time-varying weights for the gyrokinetic Vlasov-Poisson system have been developed. The primary purpose is to use them for the removal of the selected nonlinearities in the simulation of gradient-driven microturbulence so that the relative importance of the various nonlinear effects can be assessed. It is hoped that the use of these procedures will result in a better understanding of the transport mechanisms and scaling in tokamaks. Another application of these algorithms is for the improvement of the numerical properties of the simulation plasma. For instance, implementations of such algorithms (1) enable us to suppress the intrinsic numerical noise in the simulation, and (2) also make it possible to regulate the weights of the fast-moving particles and, in turn, to eliminate the associated high frequency oscillations. Examples of their application to drift-type instabilities in slab geometry are given. We note that the work reported here represents the first successful use of the weighted algorithms in particle codes for the nonlinear simulation of plasmas.

  19. Partially linearized algorithms in gyrokinetic particle simulation

    International Nuclear Information System (INIS)

    Dimits, A.M.; Lee, W.W.

    1990-10-01

    In this paper, particle simulation algorithms with time-varying weights for the gyrokinetic Vlasov-Poisson system have been developed. The primary purpose is to use them for the removal of the selected nonlinearities in the simulation of gradient-driven microturbulence so that the relative importance of the various nonlinear effects can be assessed. It is hoped that the use of these procedures will result in a better understanding of the transport mechanisms and scaling in tokamaks. Another application of these algorithms is for the improvement of the numerical properties of the simulation plasma. For instance, implementations of such algorithms (1) enable us to suppress the intrinsic numerical noise in the simulation, and (2) also make it possible to regulate the weights of the fast-moving particles and, in turn, to eliminate the associated high frequency oscillations. Examples of their application to drift-type instabilities in slab geometry are given. We note that the work reported here represents the first successful use of the weighted algorithms in particle codes for the nonlinear simulation of plasmas

  20. Development of hybrid genetic-algorithm-based neural networks using regression trees for modeling air quality inside a public transportation bus.

    Science.gov (United States)

    Kadiyala, Akhil; Kaur, Devinder; Kumar, Ashok

    2013-02-01

    The present study developed a novel approach to modeling indoor air quality (IAQ) of a public transportation bus by the development of hybrid genetic-algorithm-based neural networks (also known as evolutionary neural networks) with input variables optimized from using the regression trees, referred as the GART approach. This study validated the applicability of the GART modeling approach in solving complex nonlinear systems by accurately predicting the monitored contaminants of carbon dioxide (CO2), carbon monoxide (CO), nitric oxide (NO), sulfur dioxide (SO2), 0.3-0.4 microm sized particle numbers, 0.4-0.5 microm sized particle numbers, particulate matter (PM) concentrations less than 1.0 microm (PM10), and PM concentrations less than 2.5 microm (PM2.5) inside a public transportation bus operating on 20% grade biodiesel in Toledo, OH. First, the important variables affecting each monitored in-bus contaminant were determined using regression trees. Second, the analysis of variance was used as a complimentary sensitivity analysis to the regression tree results to determine a subset of statistically significant variables affecting each monitored in-bus contaminant. Finally, the identified subsets of statistically significant variables were used as inputs to develop three artificial neural network (ANN) models. The models developed were regression tree-based back-propagation network (BPN-RT), regression tree-based radial basis function network (RBFN-RT), and GART models. Performance measures were used to validate the predictive capacity of the developed IAQ models. The results from this approach were compared with the results obtained from using a theoretical approach and a generalized practicable approach to modeling IAQ that included the consideration of additional independent variables when developing the aforementioned ANN models. The hybrid GART models were able to capture majority of the variance in the monitored in-bus contaminants. The genetic-algorithm

  1. Ant colony algorithm implementation in electron and photon Monte Carlo transport: application to the commissioning of radiosurgery photon beams.

    Science.gov (United States)

    García-Pareja, S; Galán, P; Manzano, F; Brualla, L; Lallena, A M

    2010-07-01

    In this work, the authors describe an approach which has been developed to drive the application of different variance-reduction techniques to the Monte Carlo simulation of photon and electron transport in clinical accelerators. The new approach considers the following techniques: Russian roulette, splitting, a modified version of the directional bremsstrahlung splitting, and the azimuthal particle redistribution. Their application is controlled by an ant colony algorithm based on an importance map. The procedure has been applied to radiosurgery beams. Specifically, the authors have calculated depth-dose profiles, off-axis ratios, and output factors, quantities usually considered in the commissioning of these beams. The agreement between Monte Carlo results and the corresponding measurements is within approximately 3%/0.3 mm for the central axis percentage depth dose and the dose profiles. The importance map generated in the calculation can be used to discuss simulation details in the different parts of the geometry in a simple way. The simulation CPU times are comparable to those needed within other approaches common in this field. The new approach is competitive with those previously used in this kind of problems (PSF generation or source models) and has some practical advantages that make it to be a good tool to simulate the radiation transport in problems where the quantities of interest are difficult to obtain because of low statistics.

  2. Ant colony algorithm implementation in electron and photon Monte Carlo transport: Application to the commissioning of radiosurgery photon beams

    Energy Technology Data Exchange (ETDEWEB)

    Garcia-Pareja, S.; Galan, P.; Manzano, F.; Brualla, L.; Lallena, A. M. [Servicio de Radiofisica Hospitalaria, Hospital Regional Universitario ' ' Carlos Haya' ' , Avda. Carlos Haya s/n, E-29010 Malaga (Spain); Unidad de Radiofisica Hospitalaria, Hospital Xanit Internacional, Avda. de los Argonautas s/n, E-29630 Benalmadena (Malaga) (Spain); NCTeam, Strahlenklinik, Universitaetsklinikum Essen, Hufelandstr. 55, D-45122 Essen (Germany); Departamento de Fisica Atomica, Molecular y Nuclear, Universidad de Granada, E-18071 Granada (Spain)

    2010-07-15

    Purpose: In this work, the authors describe an approach which has been developed to drive the application of different variance-reduction techniques to the Monte Carlo simulation of photon and electron transport in clinical accelerators. Methods: The new approach considers the following techniques: Russian roulette, splitting, a modified version of the directional bremsstrahlung splitting, and the azimuthal particle redistribution. Their application is controlled by an ant colony algorithm based on an importance map. Results: The procedure has been applied to radiosurgery beams. Specifically, the authors have calculated depth-dose profiles, off-axis ratios, and output factors, quantities usually considered in the commissioning of these beams. The agreement between Monte Carlo results and the corresponding measurements is within {approx}3%/0.3 mm for the central axis percentage depth dose and the dose profiles. The importance map generated in the calculation can be used to discuss simulation details in the different parts of the geometry in a simple way. The simulation CPU times are comparable to those needed within other approaches common in this field. Conclusions: The new approach is competitive with those previously used in this kind of problems (PSF generation or source models) and has some practical advantages that make it to be a good tool to simulate the radiation transport in problems where the quantities of interest are difficult to obtain because of low statistics.

  3. Ant colony algorithm implementation in electron and photon Monte Carlo transport: Application to the commissioning of radiosurgery photon beams

    International Nuclear Information System (INIS)

    Garcia-Pareja, S.; Galan, P.; Manzano, F.; Brualla, L.; Lallena, A. M.

    2010-01-01

    Purpose: In this work, the authors describe an approach which has been developed to drive the application of different variance-reduction techniques to the Monte Carlo simulation of photon and electron transport in clinical accelerators. Methods: The new approach considers the following techniques: Russian roulette, splitting, a modified version of the directional bremsstrahlung splitting, and the azimuthal particle redistribution. Their application is controlled by an ant colony algorithm based on an importance map. Results: The procedure has been applied to radiosurgery beams. Specifically, the authors have calculated depth-dose profiles, off-axis ratios, and output factors, quantities usually considered in the commissioning of these beams. The agreement between Monte Carlo results and the corresponding measurements is within ∼3%/0.3 mm for the central axis percentage depth dose and the dose profiles. The importance map generated in the calculation can be used to discuss simulation details in the different parts of the geometry in a simple way. The simulation CPU times are comparable to those needed within other approaches common in this field. Conclusions: The new approach is competitive with those previously used in this kind of problems (PSF generation or source models) and has some practical advantages that make it to be a good tool to simulate the radiation transport in problems where the quantities of interest are difficult to obtain because of low statistics.

  4. Multi-level nonlinear diffusion acceleration method for multigroup transport k-Eigenvalue problems

    International Nuclear Information System (INIS)

    Anistratov, Dmitriy Y.

    2011-01-01

    The nonlinear diffusion acceleration (NDA) method is an efficient and flexible transport iterative scheme for solving reactor-physics problems. This paper presents a fast iterative algorithm for solving multigroup neutron transport eigenvalue problems in 1D slab geometry. The proposed method is defined by a multi-level system of equations that includes multigroup and effective one-group low-order NDA equations. The Eigenvalue is evaluated in the exact projected solution space of smallest dimensionality, namely, by solving the effective one- group eigenvalue transport problem. Numerical results that illustrate performance of the new algorithm are demonstrated. (author)

  5. Development of a tracer transport option for the NAPSAC fracture network computer code

    International Nuclear Information System (INIS)

    Herbert, A.W.

    1990-06-01

    The Napsac computer code predicts groundwater flow through fractured rock using a direct fracture network approach. This paper describes the development of a tracer transport algorithm for the NAPSAC code. A very efficient particle-following approach is used enabling tracer transport to be predicted through large fracture networks. The new algorithm is tested against three test examples. These demonstrations confirm the accuracy of the code for simple networks, where there is an analytical solution to the transport problem, and illustrates the use of the computer code on a more realistic problem. (author)

  6. Application of Fuzzy Sets for the Improvement of Routing Optimization Heuristic Algorithms

    Directory of Open Access Journals (Sweden)

    Mattas Konstantinos

    2016-12-01

    Full Text Available The determination of the optimal circular path has become widely known for its difficulty in producing a solution and for the numerous applications in the scope of organization and management of passenger and freight transport. It is a mathematical combinatorial optimization problem for which several deterministic and heuristic models have been developed in recent years, applicable to route organization issues, passenger and freight transport, storage and distribution of goods, waste collection, supply and control of terminals, as well as human resource management. Scope of the present paper is the development, with the use of fuzzy sets, of a practical, comprehensible and speedy heuristic algorithm for the improvement of the ability of the classical deterministic algorithms to identify optimum, symmetrical or non-symmetrical, circular route. The proposed fuzzy heuristic algorithm is compared to the corresponding deterministic ones, with regard to the deviation of the proposed solution from the best known solution and the complexity of the calculations needed to obtain this solution. It is shown that the use of fuzzy sets reduced up to 35% the deviation of the solution identified by the classical deterministic algorithms from the best known solution.

  7. Investigation at Low Speeds of the Effect of Aspect Ratio and Sweep on Rolling Stability Derivatives of Untapered Wings

    Science.gov (United States)

    Goodman, Alex; Fisher, Lewis R

    1950-01-01

    A low-scale wind-tunnel investigation was conducted in rolling flow to determine the effects of aspect ratio and sweep (when varied independently) on the rolling stability derivatives for a series of untapered wings. The rolling-flow equipment of the Langley stability tunnel was used for the tests. The data of the investigation have been used to develop a method of accounting for the effects of the drag on the yawing moment due to rolling throughout the lift range.

  8. Development of the Contiguous-cells Transportation Problem

    Directory of Open Access Journals (Sweden)

    O. E. Charles-Owaba

    2015-08-01

    Full Text Available The issue of scheduling a long string of multi-period activities which have to be completed without interruption has always been an industrial challenge. The existing production/maintenance scheduling algorithms can only handle situations where activities can be split into two or more sets of activities carried out in non-contiguous sets of work periods. This study proposes a contiguous-periods production/maintenance scheduling approach using the Transportation Model. Relevant variables and parameters of contiguous-cells scheduling problem were taken from the literature. A scheduling optimization problem was defined and solved using a contiguous-cells transportation algorithm (CCTA which was applied in order to determine the optimal maintenance schedule of a fleet of ships at a dockyard in South-Western Nigeria. Fifteen different problems were solved. It is concluded that the contiguous-cells transportation approach to production/ maintenance scheduling is feasible. The model will be a useful decision support tool for scheduling maintenance operations.

  9. Automated Measurement of Fast Mitochondrial Transport in Neurons

    Directory of Open Access Journals (Sweden)

    Kyle eMiller

    2015-11-01

    Full Text Available There is a growing recognition that fast mitochondrial transport in neurons is disrupted in multiple neurological diseases and psychiatric disorders. However a major constraint in identifying novel therapeutics based on mitochondrial transport is that the large-scale analysis of fast transport is time consuming. Here we describe methodologies for the automated analysis of fast mitochondrial transport from data acquired using a robotic microscope. We focused on addressing questions of measurement precision, speed, reliably, workflow ease, statistical processing and presentation. We used optical flow and particle tracking algorithms, implemented in ImageJ, to measure mitochondrial movement in primary cultured cortical and hippocampal neurons. With it, we are able to generate complete descriptions of movement profiles in an automated fashion of hundred of thousands of mitochondria with a processing time of approximately one hour. We describe the calibration of the parameters of the tracking algorithms and demonstrate that they are capable of measuring the fast transport of a single mitochondrion. We then show that the methods are capable of reliably measuring the inhibition of fast mitochondria transport induced by the disruption of microtubules with the drug nocodazole in both hippocampal and cortical neurons. This work lays the foundation for future large-scale screens designed to identify compounds that modulate mitochondrial motility.

  10. Método de varredura para exame de criadouros de vetores de dengue e febre amarela urbana Sweeping method to scan breeding places for dengue and urban yellow fever vectors

    Directory of Open Access Journals (Sweden)

    Roseane Lieko Kubota

    2003-04-01

    Full Text Available Com objetivo de estimar o número mínimo de varreduras para coletar uma amostra representativa das larvas presentes em um grande recipiente, foram adicionadas 200 larvas de quarto estádio em um tambor de 80 litros de água. Com auxílio de peneira plástica, foram feitas dez varreduras em cada réplica do experimento. Os resultados indicaram que oito varreduras foram suficientes para coletar até 72% do total de 200 larvas de quarto estadio presentes no criadouro, ou seja, uma média de 143±1,97. A técnica mostrou ser de fácil e eficiente execução quanto à inspeção de criadouros com grande volume de água. Isto reforça sua utilização como instrumento com grande potencial para vigilância vetorial na rotina dos programas de controle de vetores do dengue e febre amarela.To estimate the minimum numbers of "sweepings" for a representative sampling of larvae in a large container. 200 larvae in 4th stage were added in an 80-liter drum to carry out the experiment, in each retort was made 10 sweepings using a plastic sieve. Two hundred larvae in stage 4 were added to an 80-liter-drum and using a plastic sieve10 sweepings were carried out in each experiment replicate. The results showed that 8 sweepings were enough to collect up to 72% of the total sample in the container, i.e., an average of 143±1.97. The proposed method proved to be easily and effectively implemented and allowed for the inspection of containers with large water volumes. These findings reinforce its use as an important potential tool in the routine vectorial surveillance of control programs of dengue and yellow fever.

  11. A Bayesian Additive Model for Understanding Public Transport Usage in Special Events

    DEFF Research Database (Denmark)

    Rodrigues, Filipe; Borysov, Stanislav S.; Ribeiro, Bernardete

    2017-01-01

    Public special events, like sports games, concerts and festivals are well known to create disruptions in transportation systems, often catching the operators by surprise. Although these are usually planned well in advance, their impact is difficult to predict, even when organisers...... additive model with Gaussian process components that combines smart card records from public transport with context information about events that is continuously mined from the Web. We develop an efficient approximate inference algorithm using expectation propagation, which allows us to predict the total...... number of public transportation trips to the special event areas, thereby contributing to a more adaptive transportation system. Furthermore, for multiple concurrent event scenarios, the proposed algorithm is able to disaggregate gross trip counts into their most likely components related to specific...

  12. The Influence of Sweep on the Aerodynamic Loading of an Oscillating NACA0012 Airfoil. Volume 2: Data Report

    Science.gov (United States)

    St.hilaire, A. O.; Carta, F. O.

    1979-01-01

    The effect of sweep on the dynamic response of the NACA 0012 airfoil was investigated. Unsteady chordwise distributed pressure data were obtained from a tunnel spanning wing equipped with 21 single surface transducers (13 on the suction side and 8 on the pressure side of the airfoil). The pressure data were obtained at pitching amplitudes of 8 and 10 degrees over a tunnel Mach number range of 0.10 to 0.46 and a pitching frequency range of 2.5 to 10.6 cycles per second. The wing was oscillated in the unswept and swept positions about the quarter-chord pivot axis relative to mean incidence angle settings of 0, 9, 12, and 15 degrees. A compilation of all the response data obtained during the test program is presented. These data are in the form of normal force, chord force, lift force, pressure drag, and moment hysteresis loops derived from chordwise integrations of the unsteady pressure distributions. The hysteresis loops are organized in two main sections. In the first section, the loop data are arranged to show the effect of sweep (lambda = 0 and 30 deg) for all available combinations of mean incidence angle, pitching amplitude, reduced frequency, and chordwise Mach number. The second section shows the effect of chordwise Mach number (MC = 0.30 and MC = 0.40) on the swept wing response for all available combinations of mean incidence angle, pitching amplitude, and reduced frequency.

  13. Hitchhiking and Selective Sweeps of Plasmodium falciparum Sulfadoxine and Pyrimethamine Resistance Alleles in a Population from Central Africa▿ †

    Science.gov (United States)

    McCollum, Andrea M.; Basco, Leonardo K.; Tahar, Rachida; Udhayakumar, Venkatachalam; Escalante, Ananias A.

    2008-01-01

    Sulfadoxine-pyrimethamine (SP) resistance in Plasmodium falciparum is encoded by a number of mutations in the dihydrofolate reductase (dhfr) and dihydropteroate synthetase (dhps) genes. Here, we have characterized point mutations in dhfr and dhps and microsatellite loci around dhfr on chromosome 4 and dhps on chromosome 8 as well as neutral markers on chromosomes 2 and 3 in 332 samples from Yaoundé, Cameroon. The triple mutant dhfr haplotype that originated in Southeast Asia is the most predominant in this sample set, but we also find additional independent haplotypes at low frequency and an incipient process of genetic differentiation among alleles of Southeast Asian origin. As reported for other African populations, we find evidence of a selective sweep for resistant dhfr mutants in this Cameroonian population due to drug selection. Although we find evidence for a selective sweep in dhps mutants associated with SP resistance, the dynamics of dhps mutants appear different than those observed for dhfr mutants. Overall, our results yield support for the use of microsatellite markers to track resistant parasites; however, the detection of resistant dhfr alleles in low frequency, the evidence of divergence among dhfr alleles that share a common evolutionary origin, and the distinct dynamics of resistant dhps alleles emphasize the importance of comprehensive, population-based investigations to evaluate the effects of drug selection on parasite populations. PMID:18765692

  14. Production of artificial ionospheric layers by frequency sweeping near the 2nd gyroharmonic

    Directory of Open Access Journals (Sweden)

    T. Pedersen

    2011-01-01

    Full Text Available Artificial ionospheric plasmas descending from the background F-region have been observed on multiple occasions at the High Frequency Active Auroral Research Program (HAARP facility since it reached full 3.6 MW power. Proximity of the transmitter frequency to the 2nd harmonic of the electron gyrofrequency (2fce has been noted as a requirement for their occurrence, and their disappearance after only a few minutes has been attributed to the increasing frequency mismatch at lower altitudes. We report new experiments employing frequency sweeps to match 2fce in the artificial plasmas as they descend. In addition to revealing the dependence on the 2fce resonance, this technique reliably produces descending plasmas in multiple transmitter beam positions and appears to increase their stability and lifetime. High-speed ionosonde measurements are used to monitor the altitude and density of the artificial plasmas during both the formation and decay stages.

  15. GPU accelerated simulations of 3D deterministic particle transport using discrete ordinates method

    International Nuclear Information System (INIS)

    Gong Chunye; Liu Jie; Chi Lihua; Huang Haowei; Fang Jingyue; Gong Zhenghu

    2011-01-01

    Graphics Processing Unit (GPU), originally developed for real-time, high-definition 3D graphics in computer games, now provides great faculty in solving scientific applications. The basis of particle transport simulation is the time-dependent, multi-group, inhomogeneous Boltzmann transport equation. The numerical solution to the Boltzmann equation involves the discrete ordinates (S n ) method and the procedure of source iteration. In this paper, we present a GPU accelerated simulation of one energy group time-independent deterministic discrete ordinates particle transport in 3D Cartesian geometry (Sweep3D). The performance of the GPU simulations are reported with the simulations of vacuum boundary condition. The discussion of the relative advantages and disadvantages of the GPU implementation, the simulation on multi GPUs, the programming effort and code portability are also reported. The results show that the overall performance speedup of one NVIDIA Tesla M2050 GPU ranges from 2.56 compared with one Intel Xeon X5670 chip to 8.14 compared with one Intel Core Q6600 chip for no flux fixup. The simulation with flux fixup on one M2050 is 1.23 times faster than on one X5670.

  16. GPU accelerated simulations of 3D deterministic particle transport using discrete ordinates method

    Science.gov (United States)

    Gong, Chunye; Liu, Jie; Chi, Lihua; Huang, Haowei; Fang, Jingyue; Gong, Zhenghu

    2011-07-01

    Graphics Processing Unit (GPU), originally developed for real-time, high-definition 3D graphics in computer games, now provides great faculty in solving scientific applications. The basis of particle transport simulation is the time-dependent, multi-group, inhomogeneous Boltzmann transport equation. The numerical solution to the Boltzmann equation involves the discrete ordinates ( Sn) method and the procedure of source iteration. In this paper, we present a GPU accelerated simulation of one energy group time-independent deterministic discrete ordinates particle transport in 3D Cartesian geometry (Sweep3D). The performance of the GPU simulations are reported with the simulations of vacuum boundary condition. The discussion of the relative advantages and disadvantages of the GPU implementation, the simulation on multi GPUs, the programming effort and code portability are also reported. The results show that the overall performance speedup of one NVIDIA Tesla M2050 GPU ranges from 2.56 compared with one Intel Xeon X5670 chip to 8.14 compared with one Intel Core Q6600 chip for no flux fixup. The simulation with flux fixup on one M2050 is 1.23 times faster than on one X5670.

  17. Ramp - Metering Algorithms Evaluated within Simplified Conditions

    Science.gov (United States)

    Janota, Aleš; Holečko, Peter; Gregor, Michal; Hruboš, Marián

    2017-12-01

    Freeway networks reach their limits, since it is usually impossible to increase traffic volumes by indefinitely extending transport infrastructure through adding new traffic lanes. One of the possible solutions is to use advanced intelligent transport systems, particularly ramp metering systems. The paper shows how two particular algorithms of local and traffic-responsive control (Zone, ALINEA) can be adapted to simplified conditions corresponding to Slovak freeways. Both control strategies are modelled and simulated using PTV Vissim software, including the module VisVAP. Presented results demonstrate the properties of both control strategies, which are compared mutually as well as with the initial situation in which no control strategy is applied

  18. Ramp - Metering Algorithms Evaluated within Simplified Conditions

    Directory of Open Access Journals (Sweden)

    Janota Aleš

    2017-12-01

    Full Text Available Freeway networks reach their limits, since it is usually impossible to increase traffic volumes by indefinitely extending transport infrastructure through adding new traffic lanes. One of the possible solutions is to use advanced intelligent transport systems, particularly ramp metering systems. The paper shows how two particular algorithms of local and traffic-responsive control (Zone, ALINEA can be adapted to simplified conditions corresponding to Slovak freeways. Both control strategies are modelled and simulated using PTV Vissim software, including the module VisVAP. Presented results demonstrate the properties of both control strategies, which are compared mutually as well as with the initial situation in which no control strategy is applied

  19. Numerical simulations for radiation hydrodynamics. 2: Transport limit

    International Nuclear Information System (INIS)

    Dai, W.W.; Woodward, P.R.

    2000-01-01

    A finite difference scheme is proposed for two-dimensional radiation hydrodynamical equations in the transport limit. The scheme is of Godunov-type, in which the set of time-averaged flux needed in the scheme is calculated through Riemann problems solved. In the scheme, flow signals are explicitly treated, while radiation signals are implicitly treated. Flow fields and radiation fields are updated simultaneously. An iterative approach is proposed to solve the set of nonlinear algebraic equations arising from the implicitness of the scheme. The sweeping method used in the scheme significantly reduces the number of iterations or computer CPU time needed. A new approach to further accelerate the convergence is proposed, which further reduces the number of iterations needed by more than one order. No matter how many cells radiation signals propagate in one time step, only an extremely small number of iterations are needed in the scheme, and each iteration costs only about 0.8% of computer CPU time which is needed for one time step of a second order accurate and fully explicit scheme. Two-dimensional problems are treated through a dimensionally split technique. Therefore, iterations for solving the set of algebraic equations are carried out only in each one-dimensional sweep. Through numerical examples it is shown that the scheme keeps the principle advantages of Godunov schemes for flow motion. In the time scale of flow motion numerical results are the same as those obtained from a second order accurate and fully explicit scheme. The acceleration of the convergence proposed in this paper may be directly applied to other hyperbolic systems. This study is important for laser fusion and astrophysics

  20. Solving the Dial-a-Ride Problem using Genetic Algorithms

    DEFF Research Database (Denmark)

    Jørgensen, Rene Munk; Larsen, Jesper; Bergvinsdottir, Kristin Berg

    2007-01-01

    In the Dial-a-Ride problem (DARP), customers request transportation from an operator. A request consists of a specified pickup location and destination location along with a desired departure or arrival time and capacity demand. The aim of DARP is to minimize transportation cost while satisfying ...... routing problems for the vehicles using a routing heuristic. The algorithm is implemented in Java and tested on publicly available data sets. The new solution method has achieved solutions comparable with the current state-of-the-art methods....

  1. Optimal planning of electric vehicle charging station at the distribution system using hybrid optimization algorithm

    DEFF Research Database (Denmark)

    Awasthi, Abhishek; Venkitusamy, Karthikeyan; Padmanaban, Sanjeevikumar

    2017-01-01

    India's ever increasing population has made it necessary to develop alternative modes of transportation with electric vehicles being the most preferred option. The major obstacle is the deteriorating impact on the utility distribution system brought about by improper setup of these charging...... stations. This paper deals with the optimal planning (siting and sizing) of charging station infrastructure in the city of Allahabad, India. This city is one of the upcoming smart cities, where electric vehicle transportation pilot project is going on under Government of India initiative. In this context......, a hybrid algorithm based on genetic algorithm and improved version of conventional particle swarm optimization is utilized for finding optimal placement of charging station in the Allahabad distribution system. The particle swarm optimization algorithm re-optimizes the received sub-optimal solution (site...

  2. 3rd International Conference on Harmony Search Algorithm

    CERN Document Server

    2017-01-01

    This book presents state-of-the-art technical contributions based around one of the most successful evolutionary optimization algorithms published to date: Harmony Search. Contributions span from novel technical derivations of this algorithm to applications in the broad fields of civil engineering, energy, transportation & mobility and health, among many others and focus not only on its cross-domain applicability, but also on its core evolutionary operators, including elements inspired from other meta-heuristics. The global scientific community is witnessing an upsurge in groundbreaking, new advances in all areas of computational intelligence, with a particular flurry of research focusing on evolutionary computation and bio-inspired optimization. Observed processes in nature and sociology have provided the basis for innovative algorithmic developments aimed at leveraging the inherent capability to adapt characterized by various animals, including ants, fireflies, wolves and humans. However, it is the beha...

  3. Simple concurrent garbage collection almost without synchronization

    NARCIS (Netherlands)

    Hesselink, Wim H.; Lali, M.I.

    We present two simple mark and sweep algorithms, A and B, for concurrent garbage collection by a single collector running concurrently with a number of mutators that concurrently modify shared data. Both algorithms are based on the ideas of Ben-Ari's classical algorithm for on-the-fly garbage

  4. Generalized emittance measurements in a beam transport line

    International Nuclear Information System (INIS)

    Skelly, J.; Gardner, C.; Luccio, A.; Kponou, A.; Reece, K.

    1991-01-01

    Motivated by the need to commission 3 beam transport lines for the new AGS Booster project, we have developed a generalized emittance-measurement program; beam line specifics are entirely resident in data tables, not in program code. For instrumentation, the program requires one or more multi-wire profile monitors; one or multiple profiles are acquired from each monitor, corresponding to one or multiple tunes of the transport line. Emittances and Twiss parameters are calculated using generalized algorithms. The required matix descriptions of the beam optics are constructed by an on-line general beam modeling program. Design of the program, its algorithms, and initial experience with it will be described. 4 refs., 2 figs., 1 tab

  5. Public transport optimisation emphasising passengers’ travel behaviour.

    OpenAIRE

    Jensen, Jens Parbo; Nielsen, Otto Anker; Prato, Carlo Giacomo

    2015-01-01

    Passengers in public transport complaining about their travel experiences are not uncommon. This might seem counterintuitive since several operators worldwide are presenting better key performance indicators year by year. The present PhD study focuses on developing optimisation algorithms to enhance the operations of public transport while explicitly emphasising passengers’ travel behaviour and preferences. Similar to economic theory, interactions between supply and demand are omnipresent in ...

  6. Video monitoring of wood transport in a free-meandering piedmont river

    Science.gov (United States)

    MacVicar, B. J.; Piégay, H.; Tougne, L.; Ali, I.

    2009-12-01

    Wood in rivers exerts an important influence on riverine habitat, sediment transport, geomorphological form, and human infrastructure. There is a need to quantify wood transport within river systems in order to understand the relevant processes and develop wood budgets at local and watershed scales. Here we present a study that uses a riverside video camera to monitor wood passage. The camera was installed at a gauging station on the Ain River, a 3500 km2 piedmont river (France), in early 2007. Video was obtained during 12 floods, including 5 that were at or greater than the bankfull discharge and one flood at twice the bankfull discharge with a return period between 2 and 5 years. An image analysis algorithm is presented that uses an intersection of intensity, gradient and image difference masks to detect moving wood objects on the surface of the water. The algorithm is compared to the results from manual detection of wood in a selection of video segments. Manual detection is also used to estimate the length, diameter, velocity, and rotation of wood pieces and to note the presence of roots and branches. Agreement between the detection algorithm and the manual detection procedure is on the order of 90%. Despite considerable scatter, results show a threshold of wood transport at approximately two-thirds bankfull, a linear relation between wood transport volume and flow discharge beyond the wood transport threshold, and a strong hysteresis effect such that wood transport is an order of magnitude higher on the rising limb than on the falling limb. Wood transport vs discharge for two floods

  7. Flow, transport and diffusion in random geometries I: a MLMC algorithm

    KAUST Repository

    Canuto, Claudio

    2015-01-07

    Multilevel Monte Carlo (MLMC) is an efficient and flexible solution for the propagation of uncertainties in complex models, where an explicit parametrization of the input randomness is not available or too expensive. We propose a general-purpose algorithm and computational code for the solution of Partial Differential Equations (PDEs) on random geoemtry and with random parameters. We make use of the key idea of MLMC, based on different discretization levels, extending it in a more general context, making use of a hierarchy of physical resolution scales, solvers, models and other numerical/geometrical discretization parameters. Modifications of the classical MLMC estimators are proposed to further reduce variance in cases where analytical convergence rates and asymptotic regimes are not available. Spheres, ellipsoids and general convex-shaped grains are placed randomly in the domain with different placing/packing algorithms and the effective properties of the heterogeneous medium are computed. These are, for example, effective diffusivities, conductivities, and reaction rates. The implementation of the Monte-Carlo estimators, the statistical samples and each single solver is done efficiently in parallel.

  8. A new three-dimensional manufacturing service composition method under various structures using improved Flower Pollination Algorithm

    Science.gov (United States)

    Zhang, Wenyu; Yang, Yushu; Zhang, Shuai; Yu, Dejian; Chen, Yong

    2018-05-01

    With the growing complexity of customer requirements and the increasing scale of manufacturing services, how to select and combine the single services to meet the complex demand of the customer has become a growing concern. This paper presents a new manufacturing service composition method to solve the multi-objective optimization problem based on quality of service (QoS). The proposed model not only presents different methods for calculating the transportation time and transportation cost under various structures but also solves the three-dimensional composition optimization problem, including service aggregation, service selection, and service scheduling simultaneously. Further, an improved Flower Pollination Algorithm (IFPA) is proposed to solve the three-dimensional composition optimization problem using a matrix-based representation scheme. The mutation operator and crossover operator of the Differential Evolution (DE) algorithm are also used to extend the basic Flower Pollination Algorithm (FPA) to improve its performance. Compared to Genetic Algorithm, DE, and basic FPA, the experimental results confirm that the proposed method demonstrates superior performance than other meta heuristic algorithms and can obtain better manufacturing service composition solutions.

  9. Singlet Oxygen Production by Illuminated Road Dust and Winter Street Sweepings

    Science.gov (United States)

    Schneider, S.; Gan, L.; Gao, S.; Hoy, K. S.; Kwasny, J. R.; Styler, S. A.

    2017-12-01

    Road dust is an important urban source of primary particulate matter, especially in cities where sand and other traction materials are applied to roadways in winter. Although the composition and detrimental health effects of road dust are reasonably well characterized, little is currently known regarding its chemical behaviour. Motivated by our previous work, in which we showed that road dust is a photochemical source of singlet oxygen (1O2), we investigated 1O2 production by bulk winter street sweepings and by road dust collected in a variety of urban, industrial, and suburban locations in both autumn and spring. In all cases, the production of 1O2 by road dust was greater than that by Arizona test dust and desert-sourced dust, which highlights the unique photochemical environment afforded by this substrate. Mechanistically, we observed correlations between 1O2 production and the UV absorbance properties of dust extracts, which suggests the involvement of chromophoric dissolved organic matter in the observed photochemistry. Taken together, this work provides evidence that road dust-mediated photochemistry may influence the environmental lifetime of pollutants that react via 1O2-mediated pathways, including polycyclic aromatic hydrocarbons.

  10. Application of cultural algorithm to generation scheduling of hydrothermal systems

    International Nuclear Information System (INIS)

    Yuan Xiaohui; Yuan Yanbin

    2006-01-01

    The daily generation scheduling of hydrothermal power systems plays an important role in the operation of electric power systems for economics and security, which is a large scale dynamic non-linear constrained optimization problem. It is difficult to solve using traditional optimization methods. This paper proposes a new cultural algorithm to solve the optimal daily generation scheduling of hydrothermal power systems. The approach takes the water transport delay time between connected reservoirs into consideration and can conveniently deal with the complicated hydraulic coupling simultaneously. An example is used to verify the correctness and effectiveness of the proposed cultural algorithm, comparing with both the Lagrange method and the genetic algorithm method. The simulation results demonstrate that the proposed algorithm has rapid convergence speed and higher solution precision. Thus, an effective method is provided to solve the optimal daily generation scheduling of hydrothermal systems

  11. Multidemand Multisource Order Quantity Allocation with Multiple Transportation Alternatives

    Directory of Open Access Journals (Sweden)

    Jun Gang

    2015-01-01

    Full Text Available This paper focuses on a multidemand multisource order quantity allocation problem with multiple transportation alternatives. To solve this problem, a bilevel multiobjective programming model under a mixed uncertain environment is proposed. Two levels of decision makers are considered in the model. On the upper level, the purchaser aims to allocate order quantity to multiple suppliers for each demand node with the consideration of three objectives: total purchase cost minimization, total delay risk minimization, and total defect risk minimization. On the lower level, each supplier attempts to optimize the transportation alternatives with total transportation and penalty costs minimization as the objective. In contrast to prior studies, considering the information asymmetry in the bilevel decision, random and fuzzy random variables are used to model uncertain parameters of the construction company and the suppliers. To solve the bilevel model, a solution method based on Kuhn-Tucker conditions, sectional genetic algorithm, and fuzzy random simulation is proposed. Finally, the applicability of the proposed model and algorithm is evaluated through a practical case from a large scale construction project. The results show that the proposed model and algorithm are efficient in dealing with practical order quantity allocation problems.

  12. Neutron transport in Eulerian coordinates with bulk material motion

    Energy Technology Data Exchange (ETDEWEB)

    Baker, Randal S., E-mail: rsb@lanl.gov [Los Alamos National Laboratory, Computational Physics Group, Los Alamos, NM (United States); Dahl, Jon A., E-mail: dahl@lanl.gov [Los Alamos National Laboratory, Computational Physics Group, Los Alamos, NM (United States); Fichtl, Erin J., E-mail: efichtl@lanl.gov [Los Alamos National Laboratory, Computational Physics Group, Los Alamos, NM (United States); Morel, Jim E., E-mail: morel@tamu.edu [Department of Nuclear Engineering, Texas A& M University, College Station, TX (United States)

    2015-12-15

    A consistent, numerically stable algorithm for the solution of the neutron transport equation in the presence of a moving material background is presented for one-dimensional spherical geometry. Manufactured solutions are used to demonstrate the correctness and stability of our numerical algorithm. The importance of including moving material corrections is shown for the r-process in proto-neutron stars.

  13. Parallel Algorithm for Wireless Data Compression and Encryption

    Directory of Open Access Journals (Sweden)

    Qin Jiancheng

    2017-01-01

    Full Text Available As the wireless network has limited bandwidth and insecure shared media, the data compression and encryption are very useful for the broadcasting transportation of big data in IoT (Internet of Things. However, the traditional techniques of compression and encryption are neither competent nor efficient. In order to solve this problem, this paper presents a combined parallel algorithm named “CZ algorithm” which can compress and encrypt the big data efficiently. CZ algorithm uses a parallel pipeline, mixes the coding of compression and encryption, and supports the data window up to 1 TB (or larger. Moreover, CZ algorithm can encrypt the big data as a chaotic cryptosystem which will not decrease the compression speed. Meanwhile, a shareware named “ComZip” is developed based on CZ algorithm. The experiment results show that ComZip in 64 b system can get better compression ratio than WinRAR and 7-zip, and it can be faster than 7-zip in the big data compression. In addition, ComZip encrypts the big data without extra consumption of computing resources.

  14. Transport Methods Conquering the Seven-Dimensional Mountain

    International Nuclear Information System (INIS)

    Graziani, F; Olson, G

    2003-01-01

    In a wide variety of applications, a significant fraction of the momentum and energy present in a physical problem is carried by the transport of particles. Depending on the circumstances, the types of particles might involve some or all of photons, neutrinos, charged particles, or neutrons. In application areas that use transport, the computational time is usually dominated by the transport calculation. Therefore, there is a potential for great synergy; progress in transport algorithms could help quicken the time to solution for many applications. The complexity, and hence expense, involved in solving the transport problem can be understood by realizing that the general solution to the Boltzmann transport equation is seven dimensional: 3 spatial coordinates, 2 angles, 1 time, and 1 for speed or energy. Low-order approximations to the transport equation are frequently used due in part to physical justification but many times simply because a solution to the full transport problem is too computationally expensive. An example is the diffusion equation, which effectively drops the two angles in phase space by assuming that a linear representation in angle is adequate. Another approximation is the grey approximation, which drops the energy variable by averaging over it. If the grey approximation is applied to the diffusion equation, the expense of solving what amounts to the simplest possible description of transport is roughly equal to the cost of implicit computational fluid dynamics. It is clear therefore, that for those application areas needing some form of transport, fast, accurate and robust transport algorithms can lead to an increase in overall code performance and a decrease in time to solution. The seven-dimensional nature of transport means that factors of 100 or 1000 improvement in computer speed or memory are quickly absorbed in slightly higher resolution in space, angle, and energy. Therefore, the biggest advances in the last few years and in the next

  15. Identification of Water Diffusivity of Inorganic Porous Materials Using Evolutionary Algorithms

    Czech Academy of Sciences Publication Activity Database

    Kočí, J.; Maděra, J.; Jerman, M.; Keppert, M.; Svora, Petr; Černý, R.

    2016-01-01

    Roč. 113, č. 1 (2016), s. 51-66 ISSN 0169-3913 Institutional support: RVO:61388980 Keywords : Evolutionary algorithms * Water transport * Inorganic porous materials * Inverse analysis Subject RIV: CA - Inorganic Chemistry Impact factor: 2.205, year: 2016

  16. Iterative schemes for parallel Sn algorithms in a shared-memory computing environment

    International Nuclear Information System (INIS)

    Haghighat, A.; Hunter, M.A.; Mattis, R.E.

    1995-01-01

    Several two-dimensional spatial domain partitioning S n transport theory algorithms are developed on the basis of different iterative schemes. These algorithms are incorporated into TWOTRAN-II and tested on the shared-memory CRAY Y-MP C90 computer. For a series of fixed-source r-z geometry homogeneous problems, it is demonstrated that the concurrent red-black algorithms may result in large parallel efficiencies (>60%) on C90. It is also demonstrated that for a realistic shielding problem, the use of the negative flux fixup causes high load imbalance, which results in a significant loss of parallel efficiency

  17. Auto Carrier Transporter Loading and Unloading Improvement

    National Research Council Canada - National Science Library

    Miller, Brian

    2003-01-01

    .... Any reduction in time and energy will result in a significant savings of money. The intent of this research is to develop an algorithm to solve the Auto Carrier Transport Pickup and Delivery Problem...

  18. Prediction of Effective Drug Combinations by an Improved Naïve Bayesian Algorithm.

    Science.gov (United States)

    Bai, Li-Yue; Dai, Hao; Xu, Qin; Junaid, Muhammad; Peng, Shao-Liang; Zhu, Xiaolei; Xiong, Yi; Wei, Dong-Qing

    2018-02-05

    Drug combinatorial therapy is a promising strategy for combating complex diseases due to its fewer side effects, lower toxicity and better efficacy. However, it is not feasible to determine all the effective drug combinations in the vast space of possible combinations given the increasing number of approved drugs in the market, since the experimental methods for identification of effective drug combinations are both labor- and time-consuming. In this study, we conducted systematic analysis of various types of features to characterize pairs of drugs. These features included information about the targets of the drugs, the pathway in which the target protein of a drug was involved in, side effects of drugs, metabolic enzymes of the drugs, and drug transporters. The latter two features (metabolic enzymes and drug transporters) were related to the metabolism and transportation properties of drugs, which were not analyzed or used in previous studies. Then, we devised a novel improved naïve Bayesian algorithm to construct classification models to predict effective drug combinations by using the individual types of features mentioned above. Our results indicated that the performance of our proposed method was indeed better than the naïve Bayesian algorithm and other conventional classification algorithms such as support vector machine and K-nearest neighbor.

  19. Prediction of Effective Drug Combinations by an Improved Naïve Bayesian Algorithm

    Directory of Open Access Journals (Sweden)

    Li-Yue Bai

    2018-02-01

    Full Text Available Drug combinatorial therapy is a promising strategy for combating complex diseases due to its fewer side effects, lower toxicity and better efficacy. However, it is not feasible to determine all the effective drug combinations in the vast space of possible combinations given the increasing number of approved drugs in the market, since the experimental methods for identification of effective drug combinations are both labor- and time-consuming. In this study, we conducted systematic analysis of various types of features to characterize pairs of drugs. These features included information about the targets of the drugs, the pathway in which the target protein of a drug was involved in, side effects of drugs, metabolic enzymes of the drugs, and drug transporters. The latter two features (metabolic enzymes and drug transporters were related to the metabolism and transportation properties of drugs, which were not analyzed or used in previous studies. Then, we devised a novel improved naïve Bayesian algorithm to construct classification models to predict effective drug combinations by using the individual types of features mentioned above. Our results indicated that the performance of our proposed method was indeed better than the naïve Bayesian algorithm and other conventional classification algorithms such as support vector machine and K-nearest neighbor.

  20. An EPID response calculation algorithm using spatial beam characteristics of primary, head scattered and MLC transmitted radiation

    International Nuclear Information System (INIS)

    Rosca, Florin; Zygmanski, Piotr

    2008-01-01

    We have developed an independent algorithm for the prediction of electronic portal imaging device (EPID) response. The algorithm uses a set of images [open beam, closed multileaf collimator (MLC), various fence and modified sweeping gap patterns] to separately characterize the primary and head-scatter contributions to EPID response. It also characterizes the relevant dosimetric properties of the MLC: Transmission, dosimetric gap, MLC scatter [P. Zygmansky et al., J. Appl. Clin. Med. Phys. 8(4) (2007)], inter-leaf leakage, and tongue and groove [F. Lorenz et al., Phys. Med. Biol. 52, 5985-5999 (2007)]. The primary radiation is modeled with a single Gaussian distribution defined at the target position, while the head-scatter radiation is modeled with a triple Gaussian distribution defined downstream of the target. The distances between the target and the head-scatter source, jaws, and MLC are model parameters. The scatter associated with the EPID is implicit in the model. Open beam images are predicted to within 1% of the maximum value across the image. Other MLC test patterns and intensity-modulated radiation therapy fluences are predicted to within 1.5% of the maximum value. The presented method was applied to the Varian aS500 EPID but is designed to work with any planar detector with sufficient spatial resolution

  1. An Intelligent Broadcasting Algorithm for Early Warning Message Dissemination in VANETs

    Directory of Open Access Journals (Sweden)

    Ihn-Han Bae

    2015-01-01

    Full Text Available Vehicular ad hoc network (VANET has gained much attention recently to improve road safety, reduce traffic congestion, and enable efficient traffic management because of its many important applications in transportation. In this paper, an early warning intelligence broadcasting algorithm is proposed, EW-ICAST, to disseminate a safety message for VANETs. The proposed EW-ICAST uses not only the early warning system on the basis of time to collision (TTC but also the intelligent broadcasting algorithm on the basis of fuzzy logic. Thus, the EW-ICAST resolves effectively broadcast storm problem and meets time-critical requirement. The performance of EW-ICAST is evaluated through simulation and compared with that of other alert message dissemination algorithms. From the simulation results, we know that EW-ICAST is superior to Simple, P-persistence, and EDB algorithms.

  2. Radiative transport-based frequency-domain fluorescence tomography

    International Nuclear Information System (INIS)

    Joshi, Amit; Rasmussen, John C; Sevick-Muraca, Eva M; Wareing, Todd A; McGhee, John

    2008-01-01

    We report the development of radiative transport model-based fluorescence optical tomography from frequency-domain boundary measurements. The coupled radiative transport model for describing NIR fluorescence propagation in tissue is solved by a novel software based on the established Attila(TM) particle transport simulation platform. The proposed scheme enables the prediction of fluorescence measurements with non-contact sources and detectors at a minimal computational cost. An adjoint transport solution-based fluorescence tomography algorithm is implemented on dual grids to efficiently assemble the measurement sensitivity Jacobian matrix. Finally, we demonstrate fluorescence tomography on a realistic computational mouse model to locate nM to μM fluorophore concentration distributions in simulated mouse organs

  3. Decentralized control of multi-agent aerial transportation system

    KAUST Repository

    Toumi, Noureddine

    2017-04-01

    Autonomous aerial transportation has multiple potential applications including emergency cases and rescue missions where ground intervention may be difficult. In this context, the following work will address the control of multi-agent Vertical Take-off and Landing aircraft (VTOL) transportation system. We develop a decentralized method. The advantage of such a solution is that it can provide better maneuverability and lifting capabilities compared to existing systems. First, we consider a cooperative group of VTOLs transporting one payload. The main idea is that each agent perceive the interaction with other agents as a disturbance while assuming a negotiated motion model and imposing certain magnitude bounds on each agent. The theoretical model will be then validated using a numerical simulation illustrating the interesting features of the presented control method. Results show that under specified disturbances, the algorithm is able to guarantee the tracking with a minimal error. We describe a toolbox that has been developed for this purpose. Then, a system of multiple VTOLs lifting payloads will be studied. The algorithm assures that the VTOLs are coordinated with minimal communication. Additionally, a novel gripper design for ferrous objects is presented that enables the transportation of ferrous objects without a cable. Finally, we discuss potential connections to human in the loop transportation systems.

  4. Surface oxygen vacancy and oxygen permeation flux limits of perovskite ion transport membranes

    KAUST Repository

    Hunt, Anton

    2015-09-01

    © 2015 Elsevier B.V. The mechanisms and quantitative models for how oxygen is separated from air using ion transport membranes (ITMs) are not well understood, largely due to the experimental complexity for determining surface exchange reactions at extreme temperatures (>800°C). This is especially true when fuels are present at the permeate surface. For both inert and reactive (fuels) operations, solid-state oxygen surface vacancies (δ) are ultimately responsible for driving the oxygen flux, JO2. In the inert case, the value of δ at either surface is a function of the local PO2 and temperature, whilst the magnitude of δ dictates both the JO2 and the inherent stability of the material. In this study values of δ are presented based on experimental measurements under inert (CO2) sweep: using a permeation flux model and local PO2 measurements, collected by means of a local gas-sampling probe in our large-scale reactor, we can determine δ directly. The ITM assessed was La0.9Ca0.1FeO3-δ (LCF); the relative resistances to JO2 were quantified using the pre-defined permeation flux model and local PO2 values. Across a temperature range from 825°C to 1056°C, δ was found to vary from 0.007 to 0.029 (<1%), safely within material stability limits, whilst the permeate surface exchange resistance dominates. An inert JO2 limit was identified owing to a maximum sweep surface δ, δmaxinert. The physical presence of δmaxinert is attributed to a rate limiting step shift from desorption to associative electron transfer steps on the sweep surface as PO2 is reduced. Permeate surface exchange limitations under non-reactive conditions suggest that reactive (fuel) operation is necessary to accelerate surface chemistry for future work, to reduce flux resistance and push δpast δmaxinert in a stable manner.

  5. Optimized two-dimensional Sn transport (BISTRO)

    International Nuclear Information System (INIS)

    Palmiotti, G.; Salvatores, M.; Gho, C.

    1990-01-01

    This paper reports on an S n two-dimensional transport module developed for the French fast reactor code system CCRR to optimize algorithms in order to obtain the best performance in terms of computational time. A form of diffusion synthetic acceleration was adopted, and a special effort was made to solve the associated diffusion equation efficiently. The improvements in the algorithms, along with the use of an efficient programming language, led to a significant gain in computational time with respect to the DOT code

  6. Multi Dimensional Honey Bee Foraging Algorithm Based on Optimal Energy Consumption

    Science.gov (United States)

    Saritha, R.; Vinod Chandra, S. S.

    2017-10-01

    In this paper a new nature inspired algorithm is proposed based on natural foraging behavior of multi-dimensional honey bee colonies. This method handles issues that arise when food is shared from multiple sources by multiple swarms at multiple destinations. The self organizing nature of natural honey bee swarms in multiple colonies is based on the principle of energy consumption. Swarms of multiple colonies select a food source to optimally fulfill the requirements of its colonies. This is based on the energy requirement for transporting food between a source and destination. Minimum use of energy leads to maximizing profit in each colony. The mathematical model proposed here is based on this principle. This has been successfully evaluated by applying it on multi-objective transportation problem for optimizing cost and time. The algorithm optimizes the needs at each destination in linear time.

  7. Optimized mobile retroreflectivity unit data processing algorithms : [project summary].

    Science.gov (United States)

    2017-06-01

    Researchers examined both hardware and : software components of the MRU to determine : where improvements could be made. The MRUs laser makes one-meter sweeps, which : detect retroreflective striping and measure its reflectivity. The MRU also dete...

  8. Transport relaxation measurements and glassy state effects in superconducting MgB2

    International Nuclear Information System (INIS)

    Olutas, M.; Yetis, H.; Altinkok, A.; Kilic, A.; Kilic, K.

    2008-01-01

    Time dependent effects in superconducting MgB 2 have been studied systematically for the first time by transport relaxation measurements (V-t curves) as a function of transport current (I), temperature (T) and external magnetic field (H). At very low dissipation levels (below ∼1 μV), it was observed that the sample voltage grows up smoothly in time by exhibiting the details of initial stage of relaxation process. At high dissipation levels, steady state corresponding to constant flow rate is maintained within a very short time and monitoring of details of flux dynamic evolving along sample becomes difficult on long time scales. Another interesting behavior is the appearance of voltage peak when the transport current was reduced to a finite value. After peak, it was observed that the sample voltage relaxes smoothly by leveling off within a very short time. The evolution of V-t curves suggests that formation of resistive flow channels along sample develops easily, which is quite similar to that of obtained for the superconducting ceramic samples whose grain boundaries are improved. Time dependent effects were also observed in magnetovoltage measurements (V-H curves) as the field sweep rate (dH/dt) varies. The observations were interpreted mainly in terms of flux trapping in grains

  9. Comparison of analytical transport and stochastic solutions for neutron slowing down in an infinite medium

    International Nuclear Information System (INIS)

    Jahshan, S.N.; Wemple, C.A.; Ganapol, B.D.

    1993-01-01

    A comparison of the numerical solutions of the transport equation describing the steady neutron slowing down in an infinite medium with constant cross sections is made with stochastic solutions obtained from tracking successive neutron histories in the same medium. The transport equation solution is obtained using a numerical Laplace transform inversion algorithm. The basis for the algorithm is an evaluation of the Bromwich integral without analytical continuation. Neither the transport nor the stochastic solution is limited in the number of scattering species allowed. The medium may contain an absorption component as well. (orig.)

  10. Development and Implementation of a Transport Method for the Transport and Reaction Simulation Engine (TaRSE) based on the Godunov-Mixed Finite Element Method

    Science.gov (United States)

    James, Andrew I.; Jawitz, James W.; Munoz-Carpena, Rafael

    2009-01-01

    A model to simulate transport of materials in surface water and ground water has been developed to numerically approximate solutions to the advection-dispersion equation. This model, known as the Transport and Reaction Simulation Engine (TaRSE), uses an algorithm that incorporates a time-splitting technique where the advective part of the equation is solved separately from the dispersive part. An explicit finite-volume Godunov method is used to approximate the advective part, while a mixed-finite element technique is used to approximate the dispersive part. The dispersive part uses an implicit discretization, which allows it to run stably with a larger time step than the explicit advective step. The potential exists to develop algorithms that run several advective steps, and then one dispersive step that encompasses the time interval of the advective steps. Because the dispersive step is computationally most expensive, schemes can be implemented that are more computationally efficient than non-time-split algorithms. This technique enables scientists to solve problems with high grid Peclet numbers, such as transport problems with sharp solute fronts, without spurious oscillations in the numerical approximation to the solution and with virtually no artificial diffusion.

  11. On bi-criteria two-stage transportation problem: a case study

    Directory of Open Access Journals (Sweden)

    Ahmad MURAD

    2010-01-01

    Full Text Available The study of the optimum distribution of goods between sources and destinations is one of the important topics in projects economics. This importance comes as a result of minimizing the transportation cost, deterioration, time, etc. The classical transportation problem constitutes one of the major areas of application for linear programming. The aim of this problem is to obtain the optimum distribution of goods from different sources to different destinations which minimizes the total transportation cost. From the practical point of view, the transportation problems may differ from the classical form. It may contain one or more objective function, one or more stage to transport, one or more type of commodity with one or more means of transport. The aim of this paper is to construct an optimization model for transportation problem for one of mill-stones companies. The model is formulated as a bi-criteria two-stage transportation problem with a special structure depending on the capacities of suppliers, warehouses and requirements of the destinations. A solution algorithm is introduced to solve this class of bi-criteria two-stage transportation problem to obtain the set of non-dominated extreme points and the efficient solutions accompanied with each one that enables the decision maker to choose the best one. The solution algorithm mainly based on the fruitful application of the methods for treating transportation problems, theory of duality of linear programming and the methods of solving bi-criteria linear programming problems.

  12. System convergence in transport models: algorithms efficiency and output uncertainty

    DEFF Research Database (Denmark)

    Rich, Jeppe; Nielsen, Otto Anker

    2015-01-01

    of this paper is to analyse convergence performance for the external loop and to illustrate how an improper linkage between the converging parts can lead to substantial uncertainty in the final output. Although this loop is crucial for the performance of large-scale transport models it has not been analysed...... much in the literature. The paper first investigates several variants of the Method of Successive Averages (MSA) by simulation experiments on a toy-network. It is found that the simulation experiments produce support for a weighted MSA approach. The weighted MSA approach is then analysed on large......-scale in the Danish National Transport Model (DNTM). It is revealed that system convergence requires that either demand or supply is without random noise but not both. In that case, if MSA is applied to the model output with random noise, it will converge effectively as the random effects are gradually dampened...

  13. Traveling Salesman Problem with Transportation

    Directory of Open Access Journals (Sweden)

    Valeriu Ungureanu

    2006-09-01

    Full Text Available Traveling Salesman Problem (TSP is a generic name that includes diverse practical models. Motivated by applications, a new model of TSP is examined – a synthesis of classical TSP and classical Transportation Problem. Algorithms based on Integer Programming cutting-plane methods and Branch and Bound Techniques are obvious.

  14. Multiscale high-order/low-order (HOLO) algorithms and applications

    International Nuclear Information System (INIS)

    Chacón, L.; Chen, G.; Knoll, D.A.; Newman, C.; Park, H.; Taitano, W.; Willert, J.A.; Womeldorff, G.

    2017-01-01

    We review the state of the art in the formulation, implementation, and performance of so-called high-order/low-order (HOLO) algorithms for challenging multiscale problems. HOLO algorithms attempt to couple one or several high-complexity physical models (the high-order model, HO) with low-complexity ones (the low-order model, LO). The primary goal of HOLO algorithms is to achieve nonlinear convergence between HO and LO components while minimizing memory footprint and managing the computational complexity in a practical manner. Key to the HOLO approach is the use of the LO representations to address temporal stiffness, effectively accelerating the convergence of the HO/LO coupled system. The HOLO approach is broadly underpinned by the concept of nonlinear elimination, which enables segregation of the HO and LO components in ways that can effectively use heterogeneous architectures. The accuracy and efficiency benefits of HOLO algorithms are demonstrated with specific applications to radiation transport, gas dynamics, plasmas (both Eulerian and Lagrangian formulations), and ocean modeling. Across this broad application spectrum, HOLO algorithms achieve significant accuracy improvements at a fraction of the cost compared to conventional approaches. It follows that HOLO algorithms hold significant potential for high-fidelity system scale multiscale simulations leveraging exascale computing.

  15. Multiscale high-order/low-order (HOLO) algorithms and applications

    Energy Technology Data Exchange (ETDEWEB)

    Chacón, L., E-mail: chacon@lanl.gov [Los Alamos National Laboratory, Los Alamos, NM 87545 (United States); Chen, G.; Knoll, D.A.; Newman, C.; Park, H.; Taitano, W. [Los Alamos National Laboratory, Los Alamos, NM 87545 (United States); Willert, J.A. [Institute for Defense Analyses, Alexandria, VA 22311 (United States); Womeldorff, G. [Los Alamos National Laboratory, Los Alamos, NM 87545 (United States)

    2017-02-01

    We review the state of the art in the formulation, implementation, and performance of so-called high-order/low-order (HOLO) algorithms for challenging multiscale problems. HOLO algorithms attempt to couple one or several high-complexity physical models (the high-order model, HO) with low-complexity ones (the low-order model, LO). The primary goal of HOLO algorithms is to achieve nonlinear convergence between HO and LO components while minimizing memory footprint and managing the computational complexity in a practical manner. Key to the HOLO approach is the use of the LO representations to address temporal stiffness, effectively accelerating the convergence of the HO/LO coupled system. The HOLO approach is broadly underpinned by the concept of nonlinear elimination, which enables segregation of the HO and LO components in ways that can effectively use heterogeneous architectures. The accuracy and efficiency benefits of HOLO algorithms are demonstrated with specific applications to radiation transport, gas dynamics, plasmas (both Eulerian and Lagrangian formulations), and ocean modeling. Across this broad application spectrum, HOLO algorithms achieve significant accuracy improvements at a fraction of the cost compared to conventional approaches. It follows that HOLO algorithms hold significant potential for high-fidelity system scale multiscale simulations leveraging exascale computing.

  16. Modification of the finite element heat and mass transfer code (FEHMN) to model multicomponent reactive transport

    International Nuclear Information System (INIS)

    Viswanathan, H.S.

    1995-01-01

    The finite element code FEHMN is a three-dimensional finite element heat and mass transport simulator that can handle complex stratigraphy and nonlinear processes such as vadose zone flow, heat flow and solute transport. Scientists at LANL have been developed hydrologic flow and transport models of the Yucca Mountain site using FEHMN. Previous FEHMN simulations have used an equivalent K d model to model solute transport. In this thesis, FEHMN is modified making it possible to simulate the transport of a species with a rigorous chemical model. Including the rigorous chemical equations into FEHMN simulations should provide for more representative transport models for highly reactive chemical species. A fully kinetic formulation is chosen for the FEHMN reactive transport model. Several methods are available to computationally implement a fully kinetic formulation. Different numerical algorithms are investigated in order to optimize computational efficiency and memory requirements of the reactive transport model. The best algorithm of those investigated is then incorporated into FEHMN. The algorithm chosen requires for the user to place strongly coupled species into groups which are then solved for simultaneously using FEHMN. The complete reactive transport model is verified over a wide variety of problems and is shown to be working properly. The simulations demonstrate that gas flow and carbonate chemistry can significantly affect 14 C transport at Yucca Mountain. The simulations also provide that the new capabilities of FEHMN can be used to refine and buttress already existing Yucca Mountain radionuclide transport studies

  17. Development of numerical methods for reactive transport; Developpement de methodes numeriques pour le transport reactif

    Energy Technology Data Exchange (ETDEWEB)

    Bouillard, N

    2006-12-15

    When a radioactive waste is stored in deep geological disposals, it is expected that the waste package will be damaged under water action (concrete leaching, iron corrosion). Then, to understand these damaging processes, chemical reactions and solutes transport are modelled. Numerical simulations of reactive transport can be done sequentially by the coupling of several codes. This is the case of the software platform ALLIANCES which is developed jointly with CEA, ANDRA and EDF. Stiff reactions like precipitation-dissolution are crucial for the radioactive waste storage applications, but standard sequential iterative approaches like Picard's fail in solving rapidly reactive transport simulations with such stiff reactions. In the first part of this work, we focus on a simplified precipitation and dissolution process: a system made up with one solid species and two aqueous species moving by diffusion is studied mathematically. It is assumed that a precipitation dissolution reaction occurs in between them, and it is modelled by a discontinuous kinetics law of unknown sign. By using monotonicity properties, the convergence of a finite volume scheme on admissible mesh is proved. Existence of a weak solution is obtained as a by-product of the convergence of the scheme. The second part is dedicated to coupling algorithms which improve Picard's method and can be easily used in an existing coupling code. By extending previous works, we propose a general and adaptable framework to solve nonlinear systems. Indeed by selecting special options, we can either recover well known methods, like nonlinear conjugate gradient methods, or design specific method. This algorithm has two main steps, a preconditioning one and an acceleration one. This algorithm is tested on several examples, some of them being rather academical and others being more realistic. We test it on the 'three species model'' example. Other reactive transport simulations use an external

  18. Development of numerical methods for reactive transport; Developpement de methodes numeriques pour le transport reactif

    Energy Technology Data Exchange (ETDEWEB)

    Bouillard, N

    2006-12-15

    When a radioactive waste is stored in deep geological disposals, it is expected that the waste package will be damaged under water action (concrete leaching, iron corrosion). Then, to understand these damaging processes, chemical reactions and solutes transport are modelled. Numerical simulations of reactive transport can be done sequentially by the coupling of several codes. This is the case of the software platform ALLIANCES which is developed jointly with CEA, ANDRA and EDF. Stiff reactions like precipitation-dissolution are crucial for the radioactive waste storage applications, but standard sequential iterative approaches like Picard's fail in solving rapidly reactive transport simulations with such stiff reactions. In the first part of this work, we focus on a simplified precipitation and dissolution process: a system made up with one solid species and two aqueous species moving by diffusion is studied mathematically. It is assumed that a precipitation dissolution reaction occurs in between them, and it is modelled by a discontinuous kinetics law of unknown sign. By using monotonicity properties, the convergence of a finite volume scheme on admissible mesh is proved. Existence of a weak solution is obtained as a by-product of the convergence of the scheme. The second part is dedicated to coupling algorithms which improve Picard's method and can be easily used in an existing coupling code. By extending previous works, we propose a general and adaptable framework to solve nonlinear systems. Indeed by selecting special options, we can either recover well known methods, like nonlinear conjugate gradient methods, or design specific method. This algorithm has two main steps, a preconditioning one and an acceleration one. This algorithm is tested on several examples, some of them being rather academical and others being more realistic. We test it on the 'three species model'' example. Other reactive transport simulations use an external chemical code CHESS. For a

  19. SIMPLE-2: a computer code for calculation of steady-state thermal behavior of rod bundles with flow sweeping

    International Nuclear Information System (INIS)

    Jones, O.C. Jr.; Yao, S.; Henry, R.E.

    1976-01-01

    A computer code has been developed for use in making single-phase thermal hydraulic calculations in rod bundle arrays with flow sweeping due to spiral wraps as the predominant crossflow mixing effect. This code, called SIMPLE-2, makes the assumption that the axial pressure gradient is identical for each subchannel over a given axial increment, and is unique in that no empirical coefficients must be specified for its use. Results from this code have been favorably compared with experimental data for both uniform and highly nonuniform power distributions. Typical calculations for various bundle sizes applicable to the LMBR program are included

  20. Frequency sweep of the field scattered by an inhomogeneous structure using method of moments and asymptotic waveform evaluation

    DEFF Research Database (Denmark)

    Troelsen, Jens; Meincke, Peter; Breinbjerg, Olav

    2000-01-01

    into account. To the knowledge of the authors the AWE technique has not previously been applied to a MoM solution based on this kind of integral equation. It is the purpose of this paper to investigate the use of the AWE technique as a tool to obtain a fast frequency sweep of the field scattered......In many radar applications it is necessary to determine the scattering from an object over a wide frequency band. The asymptotic waveform evaluation (AWE), which is a moment matching (MM) technique, constitutes a method to this end. In general, MM techniques provide a reduced-order model...