WorldWideScience

Sample records for lines aligned parallel

  1. SWAMP+: multiple subsequence alignment using associative massive parallelism

    Energy Technology Data Exchange (ETDEWEB)

    Steinfadt, Shannon Irene [Los Alamos National Laboratory; Baker, Johnnie W [KENT STATE UNIV.

    2010-10-18

    A new parallel algorithm SWAMP+ incorporates the Smith-Waterman sequence alignment on an associative parallel model known as ASC. It is a highly sensitive parallel approach that expands traditional pairwise sequence alignment. This is the first parallel algorithm to provide multiple non-overlapping, non-intersecting subsequence alignments with the accuracy of Smith-Waterman. The efficient algorithm provides multiple alignments similar to BLAST while creating a better workflow for the end users. The parallel portions of the code run in O(m+n) time using m processors. When m = n, the algorithmic analysis becomes O(n) with a coefficient of two, yielding a linear speedup. Implementation of the algorithm on the SIMD ClearSpeed CSX620 confirms this theoretical linear speedup with real timings.

  2. A Set of Annotation Interfaces for Alignment of Parallel Corpora

    Directory of Open Access Journals (Sweden)

    Singh Anil Kumar

    2014-09-01

    Full Text Available Annotation interfaces for parallel corpora which fit in well with other tools can be very useful. We describe a set of annotation interfaces which fulfill this criterion. This set includes a sentence alignment interface, two different word or word group alignment interfaces and an initial version of a parallel syntactic annotation alignment interface. These tools can be used for manual alignment, or they can be used to correct automatic alignments. Manual alignment can be performed in combination with certain kinds of linguistic annotation. Most of these interfaces use a representation called the Shakti Standard Format that has been found to be very robust and has been used for large and successful projects. It ties together the different interfaces, so that the data created by them is portable across all tools which support this representation. The existence of a query language for data stored in this representation makes it possible to build tools that allow easy search and modification of annotated parallel data.

  3. Implementation of a Parallel Protein Structure Alignment Service on Cloud

    Directory of Open Access Journals (Sweden)

    Che-Lun Hung

    2013-01-01

    Full Text Available Protein structure alignment has become an important strategy by which to identify evolutionary relationships between protein sequences. Several alignment tools are currently available for online comparison of protein structures. In this paper, we propose a parallel protein structure alignment service based on the Hadoop distribution framework. This service includes a protein structure alignment algorithm, a refinement algorithm, and a MapReduce programming model. The refinement algorithm refines the result of alignment. To process vast numbers of protein structures in parallel, the alignment and refinement algorithms are implemented using MapReduce. We analyzed and compared the structure alignments produced by different methods using a dataset randomly selected from the PDB database. The experimental results verify that the proposed algorithm refines the resulting alignments more accurately than existing algorithms. Meanwhile, the computational performance of the proposed service is proportional to the number of processors used in our cloud platform.

  4. Mobile and replicated alignment of arrays in data-parallel programs

    Science.gov (United States)

    Chatterjee, Siddhartha; Gilbert, John R.; Schreiber, Robert

    1993-01-01

    When a data-parallel language like FORTRAN 90 is compiled for a distributed-memory machine, aggregate data objects (such as arrays) are distributed across the processor memories. The mapping determines the amount of residual communication needed to bring operands of parallel operations into alignment with each other. A common approach is to break the mapping into two stages: first, an alignment that maps all the objects to an abstract template, and then a distribution that maps the template to the processors. We solve two facets of the problem of finding alignments that reduce residual communication: we determine alignments that vary in loops, and objects that should have replicated alignments. We show that loop-dependent mobile alignment is sometimes necessary for optimum performance, and we provide algorithms with which a compiler can determine good mobile alignments for objects within do loops. We also identify situations in which replicated alignment is either required by the program itself (via spread operations) or can be used to improve performance. We propose an algorithm based on network flow that determines which objects to replicate so as to minimize the total amount of broadcast communication in replication. This work on mobile and replicated alignment extends our earlier work on determining static alignment.

  5. Long Read Alignment with Parallel MapReduce Cloud Platform

    Science.gov (United States)

    Al-Absi, Ahmed Abdulhakim; Kang, Dae-Ki

    2015-01-01

    Genomic sequence alignment is an important technique to decode genome sequences in bioinformatics. Next-Generation Sequencing technologies produce genomic data of longer reads. Cloud platforms are adopted to address the problems arising from storage and analysis of large genomic data. Existing genes sequencing tools for cloud platforms predominantly consider short read gene sequences and adopt the Hadoop MapReduce framework for computation. However, serial execution of map and reduce phases is a problem in such systems. Therefore, in this paper, we introduce Burrows-Wheeler Aligner's Smith-Waterman Alignment on Parallel MapReduce (BWASW-PMR) cloud platform for long sequence alignment. The proposed cloud platform adopts a widely accepted and accurate BWA-SW algorithm for long sequence alignment. A custom MapReduce platform is developed to overcome the drawbacks of the Hadoop framework. A parallel execution strategy of the MapReduce phases and optimization of Smith-Waterman algorithm are considered. Performance evaluation results exhibit an average speed-up of 6.7 considering BWASW-PMR compared with the state-of-the-art Bwasw-Cloud. An average reduction of 30% in the map phase makespan is reported across all experiments comparing BWASW-PMR with Bwasw-Cloud. Optimization of Smith-Waterman results in reducing the execution time by 91.8%. The experimental study proves the efficiency of BWASW-PMR for aligning long genomic sequences on cloud platforms. PMID:26839887

  6. Long Read Alignment with Parallel MapReduce Cloud Platform

    Directory of Open Access Journals (Sweden)

    Ahmed Abdulhakim Al-Absi

    2015-01-01

    Full Text Available Genomic sequence alignment is an important technique to decode genome sequences in bioinformatics. Next-Generation Sequencing technologies produce genomic data of longer reads. Cloud platforms are adopted to address the problems arising from storage and analysis of large genomic data. Existing genes sequencing tools for cloud platforms predominantly consider short read gene sequences and adopt the Hadoop MapReduce framework for computation. However, serial execution of map and reduce phases is a problem in such systems. Therefore, in this paper, we introduce Burrows-Wheeler Aligner’s Smith-Waterman Alignment on Parallel MapReduce (BWASW-PMR cloud platform for long sequence alignment. The proposed cloud platform adopts a widely accepted and accurate BWA-SW algorithm for long sequence alignment. A custom MapReduce platform is developed to overcome the drawbacks of the Hadoop framework. A parallel execution strategy of the MapReduce phases and optimization of Smith-Waterman algorithm are considered. Performance evaluation results exhibit an average speed-up of 6.7 considering BWASW-PMR compared with the state-of-the-art Bwasw-Cloud. An average reduction of 30% in the map phase makespan is reported across all experiments comparing BWASW-PMR with Bwasw-Cloud. Optimization of Smith-Waterman results in reducing the execution time by 91.8%. The experimental study proves the efficiency of BWASW-PMR for aligning long genomic sequences on cloud platforms.

  7. Design of multiple sequence alignment algorithms on parallel, distributed memory supercomputers.

    Science.gov (United States)

    Church, Philip C; Goscinski, Andrzej; Holt, Kathryn; Inouye, Michael; Ghoting, Amol; Makarychev, Konstantin; Reumann, Matthias

    2011-01-01

    The challenge of comparing two or more genomes that have undergone recombination and substantial amounts of segmental loss and gain has recently been addressed for small numbers of genomes. However, datasets of hundreds of genomes are now common and their sizes will only increase in the future. Multiple sequence alignment of hundreds of genomes remains an intractable problem due to quadratic increases in compute time and memory footprint. To date, most alignment algorithms are designed for commodity clusters without parallelism. Hence, we propose the design of a multiple sequence alignment algorithm on massively parallel, distributed memory supercomputers to enable research into comparative genomics on large data sets. Following the methodology of the sequential progressiveMauve algorithm, we design data structures including sequences and sorted k-mer lists on the IBM Blue Gene/P supercomputer (BG/P). Preliminary results show that we can reduce the memory footprint so that we can potentially align over 250 bacterial genomes on a single BG/P compute node. We verify our results on a dataset of E.coli, Shigella and S.pneumoniae genomes. Our implementation returns results matching those of the original algorithm but in 1/2 the time and with 1/4 the memory footprint for scaffold building. In this study, we have laid the basis for multiple sequence alignment of large-scale datasets on a massively parallel, distributed memory supercomputer, thus enabling comparison of hundreds instead of a few genome sequences within reasonable time.

  8. DIALIGN P: Fast pair-wise and multiple sequence alignment using parallel processors

    Directory of Open Access Journals (Sweden)

    Kaufmann Michael

    2004-09-01

    Full Text Available Abstract Background Parallel computing is frequently used to speed up computationally expensive tasks in Bioinformatics. Results Herein, a parallel version of the multi-alignment program DIALIGN is introduced. We propose two ways of dividing the program into independent sub-routines that can be run on different processors: (a pair-wise sequence alignments that are used as a first step to multiple alignment account for most of the CPU time in DIALIGN. Since alignments of different sequence pairs are completely independent of each other, they can be distributed to multiple processors without any effect on the resulting output alignments. (b For alignments of large genomic sequences, we use a heuristics by splitting up sequences into sub-sequences based on a previously introduced anchored alignment procedure. For our test sequences, this combined approach reduces the program running time of DIALIGN by up to 97%. Conclusions By distributing sub-routines to multiple processors, the running time of DIALIGN can be crucially improved. With these improvements, it is possible to apply the program in large-scale genomics and proteomics projects that were previously beyond its scope.

  9. Parallel plate transmission line transformer

    NARCIS (Netherlands)

    Voeten, S.J.; Brussaard, G.J.H.; Pemen, A.J.M.

    2011-01-01

    A Transmission Line Transformer (TLT) can be used to transform high-voltage nanosecond pulses. These transformers rely on the fact that the length of the pulse is shorter than the transmission lines used. This allows connecting the transmission lines in parallel at the input and in series at the

  10. BitPAl: a bit-parallel, general integer-scoring sequence alignment algorithm.

    Science.gov (United States)

    Loving, Joshua; Hernandez, Yozen; Benson, Gary

    2014-11-15

    Mapping of high-throughput sequencing data and other bulk sequence comparison applications have motivated a search for high-efficiency sequence alignment algorithms. The bit-parallel approach represents individual cells in an alignment scoring matrix as bits in computer words and emulates the calculation of scores by a series of logic operations composed of AND, OR, XOR, complement, shift and addition. Bit-parallelism has been successfully applied to the longest common subsequence (LCS) and edit-distance problems, producing fast algorithms in practice. We have developed BitPAl, a bit-parallel algorithm for general, integer-scoring global alignment. Integer-scoring schemes assign integer weights for match, mismatch and insertion/deletion. The BitPAl method uses structural properties in the relationship between adjacent scores in the scoring matrix to construct classes of efficient algorithms, each designed for a particular set of weights. In timed tests, we show that BitPAl runs 7-25 times faster than a standard iterative algorithm. Source code is freely available for download at http://lobstah.bu.edu/BitPAl/BitPAl.html. BitPAl is implemented in C and runs on all major operating systems. jloving@bu.edu or yhernand@bu.edu or gbenson@bu.edu Supplementary data are available at Bioinformatics online. © The Author 2014. Published by Oxford University Press.

  11. Accelerator and transport line survey and alignment

    International Nuclear Information System (INIS)

    Ruland, R.E.

    1991-10-01

    This paper summarizes the survey and alignment processes of accelerators and transport lines and discusses the propagation of errors associated with these processes. The major geodetic principles governing the survey and alignment measurement space are introduced and their relationship to a lattice coordinate system shown. The paper continues with a broad overview about the activities involved in the step sequence from initial absolute alignment to final smoothing. Emphasis is given to the relative alignment of components, in particular to the importance of incorporating methods to remove residual systematic effects in surveying and alignment operations. Various approaches to smoothing used at major laboratories are discussed. 47 refs., 19 figs., 1 tab

  12. Parallel algorithms for large-scale biological sequence alignment on Xeon-Phi based clusters.

    Science.gov (United States)

    Lan, Haidong; Chan, Yuandong; Xu, Kai; Schmidt, Bertil; Peng, Shaoliang; Liu, Weiguo

    2016-07-19

    Computing alignments between two or more sequences are common operations frequently performed in computational molecular biology. The continuing growth of biological sequence databases establishes the need for their efficient parallel implementation on modern accelerators. This paper presents new approaches to high performance biological sequence database scanning with the Smith-Waterman algorithm and the first stage of progressive multiple sequence alignment based on the ClustalW heuristic on a Xeon Phi-based compute cluster. Our approach uses a three-level parallelization scheme to take full advantage of the compute power available on this type of architecture; i.e. cluster-level data parallelism, thread-level coarse-grained parallelism, and vector-level fine-grained parallelism. Furthermore, we re-organize the sequence datasets and use Xeon Phi shuffle operations to improve I/O efficiency. Evaluations show that our method achieves a peak overall performance up to 220 GCUPS for scanning real protein sequence databanks on a single node consisting of two Intel E5-2620 CPUs and two Intel Xeon Phi 7110P cards. It also exhibits good scalability in terms of sequence length and size, and number of compute nodes for both database scanning and multiple sequence alignment. Furthermore, the achieved performance is highly competitive in comparison to optimized Xeon Phi and GPU implementations. Our implementation is available at https://github.com/turbo0628/LSDBS-mpi .

  13. Precise rotational alignment of x-ray transmission diffraction gratings

    International Nuclear Information System (INIS)

    Hill, S.L.

    1988-01-01

    Gold transmission diffraction gratings used for x-ray spectroscopy must sometimes be rotationally aligned to the axis of a diagnostic instrument to within sub-milliradian accuracy. We have fabricated transmission diffraction gratings with high line-densities (grating period of 200 and 300 nm) using uv holographic and x-ray lithography. Since the submicron features of the gratings are not optically visible, precision alignment is time consuming and difficult to verify in situ. We have developed a technique to write an optically visible alignment pattern onto these gratings using a scanning electron microscope (SEM). At high magnification (15000 X) several submicron lines of the grating are observable in the SEM, making it possible to write an alignment pattern parallel to the grating lines in an electron-beam-sensitive coating that overlays the grating. We create an alignment pattern by following a 1-cm-long grating line using the SEM's joystick-controlled translation stage. By following the same grating line we are assured the traveled direction of the SEM electron beam is parallel to the grating to better than 10 μradian. The electron-beam-exposed line-width can be large (5 to 15 μm wide) depending on the SEM magnification, and is therefore optically visible. The exposed pattern is eventually made a permanent feature of the grating by ion beam etching or gold electroplating. The pattern can be used to accurately align the grating to the axis of a diagnostic instrument. More importantly, the alignment of the grating can be quickly verified in situ

  14. Micropore extrusion-induced alignment transition from perpendicular to parallel of cylindrical domains in block copolymers.

    Science.gov (United States)

    Qu, Ting; Zhao, Yongbin; Li, Zongbo; Wang, Pingping; Cao, Shubo; Xu, Yawei; Li, Yayuan; Chen, Aihua

    2016-02-14

    The orientation transition from perpendicular to parallel alignment of PEO cylindrical domains of PEO-b-PMA(Az) films has been demonstrated by extruding the block copolymer (BCP) solutions through a micropore of a plastic gastight syringe. The parallelized orientation of PEO domains induced by this micropore extrusion can be recovered to perpendicular alignment via ultrasonication of the extruded BCP solutions and subsequent annealing. A plausible mechanism is proposed in this study. The BCP films can be used as templates to prepare nanowire arrays with controlled layers, which has enormous potential application in the field of integrated circuits.

  15. Parallel Lines

    Directory of Open Access Journals (Sweden)

    James G. Worner

    2017-05-01

    Full Text Available James Worner is an Australian-based writer and scholar currently pursuing a PhD at the University of Technology Sydney. His research seeks to expose masculinities lost in the shadow of Australia’s Anzac hegemony while exploring new opportunities for contemporary historiography. He is the recipient of the Doctoral Scholarship in Historical Consciousness at the university’s Australian Centre of Public History and will be hosted by the University of Bologna during 2017 on a doctoral research writing scholarship.   ‘Parallel Lines’ is one of a collection of stories, The Shapes of Us, exploring liminal spaces of modern life: class, gender, sexuality, race, religion and education. It looks at lives, like lines, that do not meet but which travel in proximity, simultaneously attracted and repelled. James’ short stories have been published in various journals and anthologies.

  16. FMIT alignment cart

    International Nuclear Information System (INIS)

    Potter, R.C.; Dauelsberg, L.B.; Clark, D.C.; Grieggs, R.J.

    1981-01-01

    The Fusion Materials Irradiation Test (FMIT) Facility alignment cart must perform several functions. It must serve as a fixture to receive the drift-tube girder assembly when it is removed from the linac tank. It must transport the girder assembly from the linac vault to the area where alignment or disassembly is to take place. It must serve as a disassembly fixture to hold the girder while individual drift tubes are removed for repair. It must align the drift tube bores in a straight line parallel to the girder, using an optical system. These functions must be performed without violating any clearances found within the building. The bore tubes of the drift tubes will be irradiated, and shielding will be included in the system for easier maintenance

  17. Structural hierarchy in flow-aligned hexagonally self-organized microphases with parallel polyelectrolytic structures

    NARCIS (Netherlands)

    Ruotsalainen, T; Torkkeli, M; Serimaa, R; Makela, T; Maki-Ontto, R; Ruokolainen, J; ten Brinke, G; Ikkala, O; Mäkelä, Tapio; Mäki-Ontto, Riikka

    2003-01-01

    We report a novel structural hierarchy where a flow-aligned hexagonal self-organized structure is combined with a polyelectrolytic self-organization on a smaller length scale and where the two structures are mutually parallel. Polystyrene-block-poly(4-vinylpyridine) (PS-block-P4VP) is selected with

  18. Survey and alignment of high energy physics accelerators and transport lines

    International Nuclear Information System (INIS)

    Ruland, R.E.

    1992-11-01

    This talk summarizes the survey and alignment processes of accelerators and transport lines and discusses the propagation of errors associated with these processes. The major geodetic principles governing the survey and alignment measurement space are revisited and their relationship to a lattice coordinate system shown. The paper continues with a broad overview about the activities involved in the step by step sequence from initial absolute alignment to final smoothing. Emphasis is given to the relative alignment of components, in particular to the importance of incorporating methods to remove residual systematic effects in surveying and alignment operations

  19. On the Parallel Elliptic Single/Multigrid Solutions about Aligned and Nonaligned Bodies Using the Virtual Machine for Multiprocessors

    Directory of Open Access Journals (Sweden)

    A. Averbuch

    1994-01-01

    Full Text Available Parallel elliptic single/multigrid solutions around an aligned and nonaligned body are presented and implemented on two multi-user and single-user shared memory multiprocessors (Sequent Symmetry and MOS and on a distributed memory multiprocessor (a Transputer network. Our parallel implementation uses the Virtual Machine for Muli-Processors (VMMP, a software package that provides a coherent set of services for explicitly parallel application programs running on diverse multiple instruction multiple data (MIMD multiprocessors, both shared memory and message passing. VMMP is intended to simplify parallel program writing and to promote portable and efficient programming. Furthermore, it ensures high portability of application programs by implementing the same services on all target multiprocessors. The performance of our algorithm is investigated in detail. It is seen to fit well the above architectures when the number of processors is less than the maximal number of grid points along the axes. In general, the efficiency in the nonaligned case is higher than in the aligned case. Alignment overhead is observed to be up to 200% in the shared-memory case and up to 65% in the message-passing case. We have demonstrated that when using VMMP, the portability of the algorithms is straightforward and efficient.

  20. GPU-based, parallel-line, omni-directional integration of measured acceleration field to obtain the 3D pressure distribution

    Science.gov (United States)

    Wang, Jin; Zhang, Cao; Katz, Joseph

    2016-11-01

    A PIV based method to reconstruct the volumetric pressure field by direct integration of the 3D material acceleration directions has been developed. Extending the 2D virtual-boundary omni-directional method (Omni2D, Liu & Katz, 2013), the new 3D parallel-line omni-directional method (Omni3D) integrates the material acceleration along parallel lines aligned in multiple directions. Their angles are set by a spherical virtual grid. The integration is parallelized on a Tesla K40c GPU, which reduced the computing time from three hours to one minute for a single realization. To validate its performance, this method is utilized to calculate the 3D pressure fields in isotropic turbulence and channel flow using the JHU DNS Databases (http://turbulence.pha.jhu.edu). Both integration of the DNS acceleration as well as acceleration from synthetic 3D particles are tested. Results are compared to other method, e.g. solution to the Pressure Poisson Equation (e.g. PPE, Ghaemi et al., 2012) with Bernoulli based Dirichlet boundary conditions, and the Omni2D method. The error in Omni3D prediction is uniformly low, and its sensitivity to acceleration errors is local. It agrees with the PPE/Bernoulli prediction away from the Dirichlet boundary. The Omni3D method is also applied to experimental data obtained using tomographic PIV, and results are correlated with deformation of a compliant wall. ONR.

  1. Significance of the Lateral Humeral Line for Evaluating Radiocapitellar Alignment in Children.

    Science.gov (United States)

    Souder, Christopher D; Roocroft, Joanna H; Edmonds, Eric W

    The radiocapitellar line (RCL) was originally described for evaluation of the alignment of the RC joint on lateral images of the elbow. Although, many authors have translated the utilization of RCL into coronal imaging, previous studies have not been performed to confirm validity. The purpose of this paper was to identify an accurate way of evaluating pediatric RC alignment in the coronal plane. Thirty-seven anteroposterior (AP) radiographs of 37 children were evaluated to determine the position of the RC joint in the coronal plane. All had acceptable magnetic resonance imaging (MRI) studies available for comparison. The lateral humeral line (LHL), consisting of a line along the lateral edge of the ossified condyle of the distal humerus parallel to the axis of the distal humeral shaft, was studied as it related to the lateral cortex of the radial neck. Three children with a confirmed diagnosis of a Bado III, lateral displaced radius, Monteggia fracture were also evaluated. The LHL passed along the edge of or lateral to the radial neck on all AP radiographs and all MRI studies. The RCL failed to intersect the capitellum on 2 AP radiographs. On MRI, the RCL also passed lateral to the capitellar ossification center in 3 patients. In addition, the RCL was seen passing through the capitellum at a mean of the lateral 30% (range, 0% to 64%) on AP radiographs and 26% (range, 0% to 48%) on MRI. For all 3 children with a Bado III Monteggia fracture, the LHL crossed the radial neck and the RCL did not intersect the capitellum. The RCL can fail to intersect the capitellar ossification center on AP radiographs and MRI in pediatric elbows without injury. The LHL consistently lies lateral to the radial neck in normal elbows and medial to the lateral aspect of the radial neck on all Bado III fracture-dislocations. It, therefore, can be used as an adjunct in evaluating the RC joint on AP imaging. The RCL most commonly intersects the lateral one third of the ossification center on

  2. Parallel field line and stream line tracing algorithms for space physics applications

    Science.gov (United States)

    Toth, G.; de Zeeuw, D.; Monostori, G.

    2004-05-01

    Field line and stream line tracing is required in various space physics applications, such as the coupling of the global magnetosphere and inner magnetosphere models, the coupling of the solar energetic particle and heliosphere models, or the modeling of comets, where the multispecies chemical equations are solved along stream lines of a steady state solution obtained with single fluid MHD model. Tracing a vector field is an inherently serial process, which is difficult to parallelize. This is especially true when the data corresponding to the vector field is distributed over a large number of processors. We designed algorithms for the various applications, which scale well to a large number of processors. In the first algorithm the computational domain is divided into blocks. Each block is on a single processor. The algorithm folows the vector field inside the blocks, and calculates a mapping of the block surfaces. The blocks communicate the values at the coinciding surfaces, and the results are interpolated. Finally all block surfaces are defined and values inside the blocks are obtained. In the second algorithm all processors start integrating along the vector field inside the accessible volume. When the field line leaves the local subdomain, the position and other information is stored in a buffer. Periodically the processors exchange the buffers, and continue integration of the field lines until they reach a boundary. At that point the results are sent back to the originating processor. Efficiency is achieved by a careful phasing of computation and communication. In the third algorithm the results of a steady state simulation are stored on a hard drive. The vector field is contained in blocks. All processors read in all the grid and vector field data and the stream lines are integrated in parallel. If a stream line enters a block, which has already been integrated, the results can be interpolated. By a clever ordering of the blocks the execution speed can be

  3. Highly parallel line-based image coding for many cores.

    Science.gov (United States)

    Peng, Xiulian; Xu, Jizheng; Zhou, You; Wu, Feng

    2012-01-01

    Computers are developing along with a new trend from the dual-core and quad-core processors to ones with tens or even hundreds of cores. Multimedia, as one of the most important applications in computers, has an urgent need to design parallel coding algorithms for compression. Taking intraframe/image coding as a start point, this paper proposes a pure line-by-line coding scheme (LBLC) to meet the need. In LBLC, an input image is processed line by line sequentially, and each line is divided into small fixed-length segments. The compression of all segments from prediction to entropy coding is completely independent and concurrent at many cores. Results on a general-purpose computer show that our scheme can get a 13.9 times speedup with 15 cores at the encoder and a 10.3 times speedup at the decoder. Ideally, such near-linear speeding relation with the number of cores can be kept for more than 100 cores. In addition to the high parallelism, the proposed scheme can perform comparatively or even better than the H.264 high profile above middle bit rates. At near-lossless coding, it outperforms H.264 more than 10 dB. At lossless coding, up to 14% bit-rate reduction is observed compared with H.264 lossless coding at the high 4:4:4 profile.

  4. MSAProbs-MPI: parallel multiple sequence aligner for distributed-memory systems.

    Science.gov (United States)

    González-Domínguez, Jorge; Liu, Yongchao; Touriño, Juan; Schmidt, Bertil

    2016-12-15

    MSAProbs is a state-of-the-art protein multiple sequence alignment tool based on hidden Markov models. It can achieve high alignment accuracy at the expense of relatively long runtimes for large-scale input datasets. In this work we present MSAProbs-MPI, a distributed-memory parallel version of the multithreaded MSAProbs tool that is able to reduce runtimes by exploiting the compute capabilities of common multicore CPU clusters. Our performance evaluation on a cluster with 32 nodes (each containing two Intel Haswell processors) shows reductions in execution time of over one order of magnitude for typical input datasets. Furthermore, MSAProbs-MPI using eight nodes is faster than the GPU-accelerated QuickProbs running on a Tesla K20. Another strong point is that MSAProbs-MPI can deal with large datasets for which MSAProbs and QuickProbs might fail due to time and memory constraints, respectively. Source code in C ++ and MPI running on Linux systems as well as a reference manual are available at http://msaprobs.sourceforge.net CONTACT: jgonzalezd@udc.esSupplementary information: Supplementary data are available at Bioinformatics online. © The Author 2016. Published by Oxford University Press. All rights reserved. For Permissions, please e-mail: journals.permissions@oup.com.

  5. Alignment Compensation for Bending Radius in TI 2 Transfer Line Magnets

    CERN Document Server

    Weterings, W

    2004-01-01

    The optics file for the TI 2 transfer lines specifies the position of the bending magnets assuming that the beam enters and exists at the centre of the vacuum pipe. In order to disbribute the deflected beam evenly inside the vacuum tube, the alignment has to be compensated by moving the magnets half of the beam deflection away from the centre of the bending radius. In this note the saggitas of the various TI 2 magnets are calculated and the alignment displacements tabulated for future reference.

  6. Robustness of average Stokes polarimetry characterization of digitally addressed parallel-aligned LCoS displays

    OpenAIRE

    Martínez Guardiola, Francisco Javier; Márquez Ruiz, Andrés; Gallego Rico, Sergi; Ortuño Sánchez, Manuel; Francés Monllor, Jorge; Beléndez Vázquez, Augusto; Pascual Villalobos, Inmaculada

    2014-01-01

    Parallel-aligned liquid crystal on silicon (PA-LCoS) displays have become the most attractive spatial light modulator device for a wide range of applications, due to their superior resolution and light efficiency, added to their phase-only capability. Recently we proposed a novel polarimetric method, based on Stokes polarimetry, enabling the characterization of their linear retardance and the magnitude of their associated phase fluctuations, if existent, as it happens in most of digital backp...

  7. On-line event reconstruction using a parallel in-memory data base

    OpenAIRE

    Argante, E; Van der Stok, P D V; Willers, Ian Malcolm

    1995-01-01

    PORS is a system designed for on-line event reconstruction in high energy physics (HEP) experiments. It uses the CPREAD reconstruction program. Central to the system is a parallel in-memory database which is used as communication medium between parallel workers. A farming control structure is implemented with PORS in a natural way. The database provides structured storage of data with a short life time. PORS serves as a case study for the construction of a methodology on how to apply parallel...

  8. Parallel inhomogeneity and the Alfven resonance. 1: Open field lines

    Science.gov (United States)

    Hansen, P. J.; Harrold, B. G.

    1994-01-01

    In light of a recent demonstration of the general nonexistence of a singularity at the Alfven resonance in cold, ideal, linearized magnetohydrodynamics, we examine the effect of a small density gradient parallel to uniform, open ambient magnetic field lines. To lowest order, energy deposition is quantitatively unaffected but occurs continuously over a thickened layer. This effect is illustrated in a numerical analysis of a plasma sheet boundary layer model with perfectly absorbing boundary conditions. Consequences of the results are discussed, both for the open field line approximation and for the ensuing closed field line analysis.

  9. Parallel transport of long mean-free-path plasma along open magnetic field lines: Parallel heat flux

    International Nuclear Information System (INIS)

    Guo Zehua; Tang Xianzhu

    2012-01-01

    In a long mean-free-path plasma where temperature anisotropy can be sustained, the parallel heat flux has two components with one associated with the parallel thermal energy and the other the perpendicular thermal energy. Due to the large deviation of the distribution function from local Maxwellian in an open field line plasma with low collisionality, the conventional perturbative calculation of the parallel heat flux closure in its local or non-local form is no longer applicable. Here, a non-perturbative calculation is presented for a collisionless plasma in a two-dimensional flux expander bounded by absorbing walls. Specifically, closures of previously unfamiliar form are obtained for ions and electrons, which relate two distinct components of the species parallel heat flux to the lower order fluid moments such as density, parallel flow, parallel and perpendicular temperatures, and the field quantities such as the magnetic field strength and the electrostatic potential. The plasma source and boundary condition at the absorbing wall enter explicitly in the closure calculation. Although the closure calculation does not take into account wave-particle interactions, the results based on passing orbits from steady-state collisionless drift-kinetic equation show remarkable agreement with fully kinetic-Maxwell simulations. As an example of the physical implications of the theory, the parallel heat flux closures are found to predict a surprising observation in the kinetic-Maxwell simulation of the 2D magnetic flux expander problem, where the parallel heat flux of the parallel thermal energy flows from low to high parallel temperature region.

  10. Alignment of dipole magnet in micro-beam line of HIRFL

    International Nuclear Information System (INIS)

    Wang Shaoming; Chen Wenjun; Yang Shengli; Cai Guozhu; Guo Yizhen; Zhou Guangming; Man Kaidi; Song Mingtao

    2010-01-01

    Microbeam irradiation facility is an experiment platform, which can reduce the beam-spot on the irradiated sample to micrometer level, and can accurately locate and count the radioactive particles. It is a powerful research tool for the irradiation material science, irradiation biology, irradiation biomedicine and micro mechanical machining. The microbeam irradiation facility requires the precise work for installation and alignment. These conditions make magnet's change for directions and positions because the location space of dipole magnets in micro-beam line of HIRFL (Heavy Ion Research Facility in Lanzhou) is very small. It is a challenge for the installation and alignment work of magnets. It was solved by transforming coordinates of benchmarks of magnets, which controlled the error of magnet setup within error tolerance range. (authors)

  11. No alignment of cattle along geomagnetic field lines found

    OpenAIRE

    Hert, J.; Jelinek, L.; Pekarek, L.; Pavlicek, A.

    2011-01-01

    This paper presents a study of the body orientation of domestic cattle on free pastures in several European states, based on Google satellite photographs. In sum, 232 herds with 3412 individuals were evaluated. Two independent groups participated in our study and came to the same conclusion that, in contradiction to the recent findings of other researchers, no alignment of the animals and of their herds along geomagnetic field lines could be found. Several possible reasons for this discrepanc...

  12. Single crystalline growth of a soluble organic semiconductor in a parallel aligned liquid crystal solvent using rubbing-treated polyimide films

    Science.gov (United States)

    Matsuzaki, Tomoya; Shibata, Yosei; Takeda, Risa; Ishinabe, Takahiro; Fujikake, Hideo

    2017-01-01

    For directional control of organic single crystals, we propose a crystal growth method using liquid crystal as the solvent. In this study, we examined the formation of 2,7-dioctyl[1]benzothieno[3,2-b][1]benzothiophene (C8-BTBT) single crystals using a parallel aligned liquid crystal (LC) cell and rubbing-treated polyimide films in order to clarify the effects of LC alignment on anisotropic C8-BTBT crystal growth. Based on the results, we found that the crystal growth direction of C8-BTBT single crystals was related to the direction of the aligned LC molecules because of rubbing treatment. Moreover, by optical evaluation, we found that the C8-BTBT single crystals have a aligned molecular structure.

  13. Cost-effective parallel optical interconnection module based on fully passive-alignment process

    Science.gov (United States)

    Son, Dong Hoon; Heo, Young Soon; Park, Hyoung-Jun; Kang, Hyun Seo; Kim, Sung Chang

    2017-11-01

    In optical interconnection technology, high-speed and large data transitions with low error rate and cost reduction are key issues for the upcoming 8K media era. The researchers present notable types of optical manufacturing structures of a four-channel parallel optical module by fully passive alignment, which are able to reduce manufacturing time and cost. Each of the components, such as vertical-cavity surface laser/positive-intrinsic negative-photodiode array, microlens array, fiber array, and receiver (RX)/transmitter (TX) integrated circuit, is integrated successfully using flip-chip bonding, die bonding, and passive alignment with a microscope. Clear eye diagrams are obtained by 25.78-Gb/s (for TX) and 25.7-Gb/s (for RX) nonreturn-to-zero signals of pseudorandom binary sequence with a pattern length of 231 to 1. The measured responsivity and minimum sensitivity of the RX are about 0.5 A/W and ≤-6.5 dBm at a bit error rate (BER) of 10-12, respectively. The optical power margin at a BER of 10-12 is 7.5 dB, and cross talk by the adjacent channel is ≤1 dB.

  14. Precise synaptic efficacy alignment suggests potentiation dominated learning

    Directory of Open Access Journals (Sweden)

    Christoph eHartmann

    2016-01-01

    Full Text Available Recent evidence suggests that parallel synapses from the same axonal branch onto the same dendritic branch have almost identical strength. It has been proposed that this alignment is only possible through learning rules that integrate activity over long time spans. However, learning mechanisms such as spike-timing-dependent plasticity (STDP are commonly assumed to be temporally local. Here, we propose that the combination of temporally local STDP and a multiplicative synaptic normalization mechanism is sufficient to explain the alignment of parallel synapses.To address this issue, we introduce three increasingly complex models: First, we model the idealized interaction of STDP and synaptic normalization in a single neuron as a simple stochastic process and derive analytically that the alignment effect can be described by a so-called Kesten process. From this we can derive that synaptic efficacy alignment requires potentiation-dominated learning regimes. We verify these conditions in a single-neuron model with independent spiking activities but more realistic synapses. As expected, we only observe synaptic efficacy alignment for long-term potentiation-biased STDP. Finally, we explore how well the findings transfer to recurrent neural networks where the learning mechanisms interact with the correlated activity of the network. We find that due to the self-reinforcing correlations in recurrent circuits under STDP, alignment occurs for both long-term potentiation- and depression-biased STDP, because the learning will be potentiation dominated in both cases due to the potentiating events induced by correlated activity. This is in line with recent results demonstrating a dominance of potentiation over depression during waking and normalization during sleep. This leads us to predict that individual spine pairs will be more similar in the morning than they are after sleep depriviation.In conclusion, we show that synaptic normalization in conjunction with

  15. BuddySuite: Command-Line Toolkits for Manipulating Sequences, Alignments, and Phylogenetic Trees.

    Science.gov (United States)

    Bond, Stephen R; Keat, Karl E; Barreira, Sofia N; Baxevanis, Andreas D

    2017-06-01

    The ability to manipulate sequence, alignment, and phylogenetic tree files has become an increasingly important skill in the life sciences, whether to generate summary information or to prepare data for further downstream analysis. The command line can be an extremely powerful environment for interacting with these resources, but only if the user has the appropriate general-purpose tools on hand. BuddySuite is a collection of four independent yet interrelated command-line toolkits that facilitate each step in the workflow of sequence discovery, curation, alignment, and phylogenetic reconstruction. Most common sequence, alignment, and tree file formats are automatically detected and parsed, and over 100 tools have been implemented for manipulating these data. The project has been engineered to easily accommodate the addition of new tools, is written in the popular programming language Python, and is hosted on the Python Package Index and GitHub to maximize accessibility. Documentation for each BuddySuite tool, including usage examples, is available at http://tiny.cc/buddysuite_wiki. All software is open source and freely available through http://research.nhgri.nih.gov/software/BuddySuite. Published by Oxford University Press on behalf of the Society for Molecular Biology and Evolution 2017. This work is written by US Government employees and is in the public domain in the US.

  16. Accelerating large-scale protein structure alignments with graphics processing units

    Directory of Open Access Journals (Sweden)

    Pang Bin

    2012-02-01

    Full Text Available Abstract Background Large-scale protein structure alignment, an indispensable tool to structural bioinformatics, poses a tremendous challenge on computational resources. To ensure structure alignment accuracy and efficiency, efforts have been made to parallelize traditional alignment algorithms in grid environments. However, these solutions are costly and of limited accessibility. Others trade alignment quality for speedup by using high-level characteristics of structure fragments for structure comparisons. Findings We present ppsAlign, a parallel protein structure Alignment framework designed and optimized to exploit the parallelism of Graphics Processing Units (GPUs. As a general-purpose GPU platform, ppsAlign could take many concurrent methods, such as TM-align and Fr-TM-align, into the parallelized algorithm design. We evaluated ppsAlign on an NVIDIA Tesla C2050 GPU card, and compared it with existing software solutions running on an AMD dual-core CPU. We observed a 36-fold speedup over TM-align, a 65-fold speedup over Fr-TM-align, and a 40-fold speedup over MAMMOTH. Conclusions ppsAlign is a high-performance protein structure alignment tool designed to tackle the computational complexity issues from protein structural data. The solution presented in this paper allows large-scale structure comparisons to be performed using massive parallel computing power of GPU.

  17. Conductance of auroral magnetic field lines

    International Nuclear Information System (INIS)

    Weimer, D.R.; Gurnett, D.A.; Goertz, C.K.

    1986-01-01

    DE-1 high-resolution double-probe electric-field data and simultaneous magnetic-field measurements are reported for two 1981 events with large electric fields which reversed over short distances. The data are presented graphically and analyzed in detail. A field-line conductance of about 1 nmho/sq m is determined for both upward and downward currents, and the ionospheric conductivity is shown, in the short-wavelength limit, to have little effect on the relationship between the (N-S) electric and (E-W) magnetic fields above the potential drop parallel to the magnetic-field lines. The results are found to be consistent with a linear relationship between the field-aligned current density and the parallel potential drop. 14 references

  18. Parallel diffusion calculation for the PHAETON on-line multiprocessor computer

    International Nuclear Information System (INIS)

    Collart, J.M.; Fedon-Magnaud, C.; Lautard, J.J.

    1987-04-01

    The aim of the PHAETON project is the design of an on-line computer in order to increase the immediate knowledge of the main operating and safety parameters in power plants. A significant stage is the computation of the three dimensional flux distribution. For cost and safety reason a computer based on a parallel microprocessor architecture has been studied. This paper presents a first approach to parallelized three dimensional diffusion calculation. A computing software has been written and built in a four processors demonstrator. We present the realization in progress, concerning the final equipment. 8 refs

  19. Automated measurement of bolometer line of sight alignment and characteristics for application in ITER

    Energy Technology Data Exchange (ETDEWEB)

    Penzel, Florian Olivier

    2015-07-01

    The line of sight (LOS) alignment and characteristic of a bolometer camera used in a fusion experiment is a crucial parameter for the measurement accuracy of the diagnostic. A robot based LOS measurement device has been developed which allows the fully automatic measurement of the two dimensional transmission function of a bolometer camera. It has been used to optimize camera prototypes for ITER and has been successfully operated in the fusion experiment ASDEX Upgrade in order to measure the LOS alignment.

  20. Magnetic field-aligned particle precipitation

    International Nuclear Information System (INIS)

    Carlson, W.

    1985-01-01

    Magnetic field-aligned particle fluxes are a common auroral phenomenon. Precipitating field-aligned electrons are seen in the vicinity of auroral arcs as suprathermal bursts, as well as superimposed on the more isotropic inverted V electron precipitation. Electron distribution functions reveal two distinct source populations for the inverted V and field-aligned electron components, and also suggest possible acceleration mechanisms. The inverted V electrons are a hot, boundary plasma sheet population that gains the full parallel acceleration. The field-aligned component appears to originate from cold ionospheric electrons that may be distributed throughout the acceleration region. A turbulent parallel field might explain the apparent lifetime of cold electrons in the acceleration region

  1. Pairwise Sequence Alignment Library

    Energy Technology Data Exchange (ETDEWEB)

    2015-05-20

    Vector extensions, such as SSE, have been part of the x86 CPU since the 1990s, with applications in graphics, signal processing, and scientific applications. Although many algorithms and applications can naturally benefit from automatic vectorization techniques, there are still many that are difficult to vectorize due to their dependence on irregular data structures, dense branch operations, or data dependencies. Sequence alignment, one of the most widely used operations in bioinformatics workflows, has a computational footprint that features complex data dependencies. The trend of widening vector registers adversely affects the state-of-the-art sequence alignment algorithm based on striped data layouts. Therefore, a novel SIMD implementation of a parallel scan-based sequence alignment algorithm that can better exploit wider SIMD units was implemented as part of the Parallel Sequence Alignment Library (parasail). Parasail features: Reference implementations of all known vectorized sequence alignment approaches. Implementations of Smith Waterman (SW), semi-global (SG), and Needleman Wunsch (NW) sequence alignment algorithms. Implementations across all modern CPU instruction sets including AVX2 and KNC. Language interfaces for C/C++ and Python.

  2. A high-quality narrow passband filter for elastic SV waves via aligned parallel separated thin polymethylmethacrylate plates

    OpenAIRE

    Jun Zhang; Yaolu Liu; Wensheng Yan; Ning Hu

    2017-01-01

    We designed a high-quality filter that consists of aligned parallel polymethylmethacrylate (PMMA) thin plates with small gaps for elastic SV waves propagate in metals. Both the theoretical model and the full numerical simulation show the transmission spectrum of the elastic SV waves through such a filter has several sharp peaks with flawless transmission within the investigated frequencies. These peaks can be readily tuned by manipulating the geometry parameters of the PMMA plates. Our invest...

  3. Alignment Compensation for Bending Radius in TT40 and TI 8 Transfer Line Magnets

    CERN Document Server

    Weterings, W

    2003-01-01

    The BEATCH file for the TI 8 transfer lines specifies the position of the bending magnets assuming that the beam enters and exits at the centre of the vacuum pipe. In order to distribute the deflected beam evenly inside the vacuum tube, the alignment has to be compensated by moving the magnets half of the beam deflection away from the centre of the bending radius. In this note the saggitas of the various TT40 and TI 8 magnets are calculated and the alignment displacements tabulated for future reference.

  4. Evaluation of alignment marks using ASML ATHENA alignment system in 90nm BEOL process

    CERN Document Server

    Tan Chin Boon; Koh Hui Peng; Koo Chee, Kiong; Siew Yong Kong; Yeo Swee Hock

    2003-01-01

    As the critical dimension (CD) in integrated circuit (IC) device reduces, the total overlay budget needs to be more stringent. Typically, the allowable overlay error is 1/3 of the CD in the IC device. In this case, robustness of alignment mark is critical, as accurate signal is required by the scanner's alignment system to precisely align a layer of pattern to the previous layer. Alignment issue is more severe in back-end process partly due to the influenced of Chemical Mechanical Polishing (CMP), which contribute to the asymmetric or total destruction of the alignment marks. Alignment marks on the wafer can be placed along the scribe-line of the IC pattern. ASML scanner allows such type of wafer alignment using phase grating mark, known as Scribe-line Primary Mark (SPM) which can be fit into a standard 80um scribe-line. In this paper, we have studied the feasibility of introducing Narrow SPM (NSPM) to enable a smaller scribe-line. The width of NSPM has been shrunk down to 70% of the SPM and the length remain...

  5. Passing in Command Line Arguments and Parallel Cluster/Multicore Batching in R with batch.

    Science.gov (United States)

    Hoffmann, Thomas J

    2011-03-01

    It is often useful to rerun a command line R script with some slight change in the parameters used to run it - a new set of parameters for a simulation, a different dataset to process, etc. The R package batch provides a means to pass in multiple command line options, including vectors of values in the usual R format, easily into R. The same script can be setup to run things in parallel via different command line arguments. The R package batch also provides a means to simplify this parallel batching by allowing one to use R and an R-like syntax for arguments to spread a script across a cluster or local multicore/multiprocessor computer, with automated syntax for several popular cluster types. Finally it provides a means to aggregate the results together of multiple processes run on a cluster.

  6. HAlign-II: efficient ultra-large multiple sequence alignment and phylogenetic tree reconstruction with distributed and parallel computing.

    Science.gov (United States)

    Wan, Shixiang; Zou, Quan

    2017-01-01

    Multiple sequence alignment (MSA) plays a key role in biological sequence analyses, especially in phylogenetic tree construction. Extreme increase in next-generation sequencing results in shortage of efficient ultra-large biological sequence alignment approaches for coping with different sequence types. Distributed and parallel computing represents a crucial technique for accelerating ultra-large (e.g. files more than 1 GB) sequence analyses. Based on HAlign and Spark distributed computing system, we implement a highly cost-efficient and time-efficient HAlign-II tool to address ultra-large multiple biological sequence alignment and phylogenetic tree construction. The experiments in the DNA and protein large scale data sets, which are more than 1GB files, showed that HAlign II could save time and space. It outperformed the current software tools. HAlign-II can efficiently carry out MSA and construct phylogenetic trees with ultra-large numbers of biological sequences. HAlign-II shows extremely high memory efficiency and scales well with increases in computing resource. THAlign-II provides a user-friendly web server based on our distributed computing infrastructure. HAlign-II with open-source codes and datasets was established at http://lab.malab.cn/soft/halign.

  7. Parallel Hough Transform-Based Straight Line Detection and Its FPGA Implementation in Embedded Vision

    Directory of Open Access Journals (Sweden)

    Nam Ling

    2013-07-01

    Full Text Available Hough Transform has been widely used for straight line detection in low-definition and still images, but it suffers from execution time and resource requirements. Field Programmable Gate Arrays (FPGA provide a competitive alternative for hardware acceleration to reap tremendous computing performance. In this paper, we propose a novel parallel Hough Transform (PHT and FPGA architecture-associated framework for real-time straight line detection in high-definition videos. A resource-optimized Canny edge detection method with enhanced non-maximum suppression conditions is presented to suppress most possible false edges and obtain more accurate candidate edge pixels for subsequent accelerated computation. Then, a novel PHT algorithm exploiting spatial angle-level parallelism is proposed to upgrade computational accuracy by improving the minimum computational step. Moreover, the FPGA based multi-level pipelined PHT architecture optimized by spatial parallelism ensures real-time computation for 1,024 × 768 resolution videos without any off-chip memory consumption. This framework is evaluated on ALTERA DE2-115 FPGA evaluation platform at a maximum frequency of 200 MHz, and it can calculate straight line parameters in 15.59 ms on the average for one frame. Qualitative and quantitative evaluation results have validated the system performance regarding data throughput, memory bandwidth, resource, speed and robustness.

  8. Parallel Hough Transform-based straight line detection and its FPGA implementation in embedded vision.

    Science.gov (United States)

    Lu, Xiaofeng; Song, Li; Shen, Sumin; He, Kang; Yu, Songyu; Ling, Nam

    2013-07-17

    Hough Transform has been widely used for straight line detection in low-definition and still images, but it suffers from execution time and resource requirements. Field Programmable Gate Arrays (FPGA) provide a competitive alternative for hardware acceleration to reap tremendous computing performance. In this paper, we propose a novel parallel Hough Transform (PHT) and FPGA architecture-associated framework for real-time straight line detection in high-definition videos. A resource-optimized Canny edge detection method with enhanced non-maximum suppression conditions is presented to suppress most possible false edges and obtain more accurate candidate edge pixels for subsequent accelerated computation. Then, a novel PHT algorithm exploiting spatial angle-level parallelism is proposed to upgrade computational accuracy by improving the minimum computational step. Moreover, the FPGA based multi-level pipelined PHT architecture optimized by spatial parallelism ensures real-time computation for 1,024 × 768 resolution videos without any off-chip memory consumption. This framework is evaluated on ALTERA DE2-115 FPGA evaluation platform at a maximum frequency of 200 MHz, and it can calculate straight line parameters in 15.59 ms on the average for one frame. Qualitative and quantitative evaluation results have validated the system performance regarding data throughput, memory bandwidth, resource, speed and robustness.

  9. Real-Time Straight-Line Detection for XGA-Size Videos by Hough Transform with Parallelized Voting Procedures.

    Science.gov (United States)

    Guan, Jungang; An, Fengwei; Zhang, Xiangyu; Chen, Lei; Mattausch, Hans Jürgen

    2017-01-30

    The Hough Transform (HT) is a method for extracting straight lines from an edge image. The main limitations of the HT for usage in actual applications are computation time and storage requirements. This paper reports a hardware architecture for HT implementation on a Field Programmable Gate Array (FPGA) with parallelized voting procedure. The 2-dimensional accumulator array, namely the Hough space in parametric form (ρ, θ), for computing the strength of each line by a voting mechanism is mapped on a 1-dimensional array with regular increments of θ. Then, this Hough space is divided into a number of parallel parts. The computation of (ρ, θ) for the edge pixels and the voting procedure for straight-line determination are therefore executable in parallel. In addition, a synchronized initialization for the Hough space further increases the speed of straight-line detection, so that XGA video processing becomes possible. The designed prototype system has been synthesized on a DE4 platform with a Stratix-IV FPGA device. In the application of road-lane detection, the average processing speed of this HT implementation is 5.4ms per XGA-frame at 200 MHz working frequency.

  10. Cloud-Coffee: implementation of a parallel consistency-based multiple alignment algorithm in the T-Coffee package and its benchmarking on the Amazon Elastic-Cloud.

    Science.gov (United States)

    Di Tommaso, Paolo; Orobitg, Miquel; Guirado, Fernando; Cores, Fernado; Espinosa, Toni; Notredame, Cedric

    2010-08-01

    We present the first parallel implementation of the T-Coffee consistency-based multiple aligner. We benchmark it on the Amazon Elastic Cloud (EC2) and show that the parallelization procedure is reasonably effective. We also conclude that for a web server with moderate usage (10K hits/month) the cloud provides a cost-effective alternative to in-house deployment. T-Coffee is a freeware open source package available from http://www.tcoffee.org/homepage.html

  11. Parallel evolution under chemotherapy pressure in 29 breast cancer cell lines results in dissimilar mechanisms of resistance.

    Directory of Open Access Journals (Sweden)

    Bálint Tegze

    Full Text Available BACKGROUND: Developing chemotherapy resistant cell lines can help to identify markers of resistance. Instead of using a panel of highly heterogeneous cell lines, we assumed that truly robust and convergent pattern of resistance can be identified in multiple parallel engineered derivatives of only a few parental cell lines. METHODS: Parallel cell populations were initiated for two breast cancer cell lines (MDA-MB-231 and MCF-7 and these were treated independently for 18 months with doxorubicin or paclitaxel. IC50 values against 4 chemotherapy agents were determined to measure cross-resistance. Chromosomal instability and karyotypic changes were determined by cytogenetics. TaqMan RT-PCR measurements were performed for resistance-candidate genes. Pgp activity was measured by FACS. RESULTS: All together 16 doxorubicin- and 13 paclitaxel-treated cell lines were developed showing 2-46 fold and 3-28 fold increase in resistance, respectively. The RT-PCR and FACS analyses confirmed changes in tubulin isofom composition, TOP2A and MVP expression and activity of transport pumps (ABCB1, ABCG2. Cytogenetics showed less chromosomes but more structural aberrations in the resistant cells. CONCLUSION: We surpassed previous studies by parallel developing a massive number of cell lines to investigate chemoresistance. While the heterogeneity caused evolution of multiple resistant clones with different resistance characteristics, the activation of only a few mechanisms were sufficient in one cell line to achieve resistance.

  12. A high-quality narrow passband filter for elastic SV waves via aligned parallel separated thin polymethylmethacrylate plates

    Directory of Open Access Journals (Sweden)

    Jun Zhang

    2017-08-01

    Full Text Available We designed a high-quality filter that consists of aligned parallel polymethylmethacrylate (PMMA thin plates with small gaps for elastic SV waves propagate in metals. Both the theoretical model and the full numerical simulation show the transmission spectrum of the elastic SV waves through such a filter has several sharp peaks with flawless transmission within the investigated frequencies. These peaks can be readily tuned by manipulating the geometry parameters of the PMMA plates. Our investigation finds that the same filter performs well for different metals where the elastic SV waves propagated.

  13. Cubic systems with invariant affine straight lines of total parallel multiplicity seven

    Directory of Open Access Journals (Sweden)

    Alexandru Suba

    2013-12-01

    Full Text Available In this article, we study the planar cubic differential systems with invariant affine straight lines of total parallel multiplicity seven. We classify these system according to their geometric properties encoded in the configurations of invariant straight lines. We show that there are only 17 different topological phase portraits in the Poincar\\'e disc associated to this family of cubic systems up to a reversal of the sense of their orbits, and we provide representatives of every class modulo an affine change of variables and rescaling of the time variable.

  14. Effect of alignment of easy axes on dynamic magnetization of immobilized magnetic nanoparticles

    Energy Technology Data Exchange (ETDEWEB)

    Yoshida, Takashi, E-mail: t_yoshi@ees.kyushu-u.ac.jp [Department of Electrical and Electronic Engineering, Kyushu University, Fukuoka 819-0395 (Japan); Matsugi, Yuki; Tsujimura, Naotaka; Sasayama, Teruyoshi; Enpuku, Keiji [Department of Electrical and Electronic Engineering, Kyushu University, Fukuoka 819-0395 (Japan); Viereck, Thilo; Schilling, Meinhard; Ludwig, Frank [Institut für Elektrische Messtechnik und Grundlagen der Elektrotechnik, TU Braunschweig, Braunschweig 38106 (Germany)

    2017-04-01

    In some biomedical applications of magnetic nanoparticles (MNPs), the particles are physically immobilized. In this study, we explore the effect of the alignment of the magnetic easy axes on the dynamic magnetization of immobilized MNPs under an AC excitation field. We prepared three immobilized MNP samples: (1) a sample in which easy axes are randomly oriented, (2) a parallel-aligned sample in which easy axes are parallel to the AC field, and (3) an orthogonally aligned sample in which easy axes are perpendicular to the AC field. First, we show that the parallel-aligned sample has the largest hysteresis in the magnetization curve and the largest harmonic magnetization spectra, followed by the randomly oriented and orthogonally aligned samples. For example, 1.6-fold increase was observed in the area of the hysteresis loop of the parallel-aligned sample compared to that of the randomly oriented sample. To quantitatively discuss the experimental results, we perform a numerical simulation based on a Fokker-Planck equation, in which probability distributions for the directions of the easy axes are taken into account in simulating the prepared MNP samples. We obtained quantitative agreement between experiment and simulation. These results indicate that the dynamic magnetization of immobilized MNPs is significantly affected by the alignment of the easy axes. - Highlights: • We clarify how the alignment of easy axis of MNP affects the AC magnetization. • Parallel-aligned immobilized MNPs exhibit the largest AC hysteresis loop. • Parallel-aligned immobilized MNPs exhibit the largest harmonic magnetization spectra. • The AC magnetization is strongly affected by the alignment of the easy axes.

  15. Airport object extraction based on visual attention mechanism and parallel line detection

    Science.gov (United States)

    Lv, Jing; Lv, Wen; Zhang, Libao

    2017-10-01

    Target extraction is one of the important aspects in remote sensing image analysis and processing, which has wide applications in images compression, target tracking, target recognition and change detection. Among different targets, airport has attracted more and more attention due to its significance in military and civilian. In this paper, we propose a novel and reliable airport object extraction model combining visual attention mechanism and parallel line detection algorithm. First, a novel saliency analysis model for remote sensing images with airport region is proposed to complete statistical saliency feature analysis. The proposed model can precisely extract the most salient region and preferably suppress the background interference. Then, the prior geometric knowledge is analyzed and airport runways contained two parallel lines with similar length are detected efficiently. Finally, we use the improved Otsu threshold segmentation method to segment and extract the airport regions from the salient map of remote sensing images. The experimental results demonstrate that the proposed model outperforms existing saliency analysis models and shows good performance in the detection of the airport.

  16. Implementation of a microcomputer based distance relay for parallel transmission lines

    International Nuclear Information System (INIS)

    Phadke, A.G.; Jihuang, L.

    1986-01-01

    Distance relaying for parallel transmission lines is a difficult application problem with conventional phase and ground distance relays. It is known that for cross-country faults involving dissimilar phases and ground, three phase tripping may result. This paper summarizes a newly developed microcomputer based relay which is capable of classifying the cross-country fault correctly. The paper describes the principle of operation and results of laboratory tests of this relay

  17. Line roughness improvements on self-aligned quadruple patterning by wafer stress engineering

    Science.gov (United States)

    Liu, Eric; Ko, Akiteru; Biolsi, Peter; Chae, Soo Doo; Hsieh, Chia-Yun; Kagaya, Munehito; Lee, Choongman; Moriya, Tsuyoshi; Tsujikawa, Shimpei; Suzuki, Yusuke; Okubo, Kazuya; Imai, Kiyotaka

    2018-04-01

    In integrated circuit and memory devices, size shrinkage has been the most effective method to reduce production cost and enable the steady increment of the number of transistors per unit area over the past few decades. In order to reduce the die size and feature size, it is necessary to minimize pattern formation in the advance node development. In the node of sub-10nm, extreme ultra violet lithography (EUV) and multi-patterning solutions based on 193nm immersionlithography are the two most common options to achieve the size requirement. In such small features of line and space pattern, line width roughness (LWR) and line edge roughness (LER) contribute significant amount of process variation that impacts both physical and electrical performances. In this paper, we focus on optimizing the line roughness performance by using wafer stress engineering on 30nm pitch line and space pattern. This pattern is generated by a self-aligned quadruple patterning (SAQP) technique for the potential application of fin formation. Our investigation starts by comparing film materials and stress levels in various processing steps and material selection on SAQP integration scheme. From the cross-matrix comparison, we are able to determine the best stack of film selection and stress combination in order to achieve the lowest line roughness performance while obtaining pattern validity after fin etch. This stack is also used to study the step-by-step line roughness performance from SAQP to fin etch. Finally, we will show a successful patterning of 30nm pitch line and space pattern SAQP scheme with 1nm line roughness performance.

  18. Integrated configurable equipment selection and line balancing for mass production with serial-parallel machining systems

    Science.gov (United States)

    Battaïa, Olga; Dolgui, Alexandre; Guschinsky, Nikolai; Levin, Genrikh

    2014-10-01

    Solving equipment selection and line balancing problems together allows better line configurations to be reached and avoids local optimal solutions. This article considers jointly these two decision problems for mass production lines with serial-parallel workplaces. This study was motivated by the design of production lines based on machines with rotary or mobile tables. Nevertheless, the results are more general and can be applied to assembly and production lines with similar structures. The designers' objectives and the constraints are studied in order to suggest a relevant mathematical model and an efficient optimization approach to solve it. A real case study is used to validate the model and the developed approach.

  19. Parallel Evolution under Chemotherapy Pressure in 29 Breast Cancer Cell Lines Results in Dissimilar Mechanisms of Resistance

    DEFF Research Database (Denmark)

    Tegze, Balint; Szallasi, Zoltan Imre; Haltrich, Iren

    2012-01-01

    Background: Developing chemotherapy resistant cell lines can help to identify markers of resistance. Instead of using a panel of highly heterogeneous cell lines, we assumed that truly robust and convergent pattern of resistance can be identified in multiple parallel engineered derivatives of only...

  20. High-throughput sequence alignment using Graphics Processing Units

    Directory of Open Access Journals (Sweden)

    Trapnell Cole

    2007-12-01

    Full Text Available Abstract Background The recent availability of new, less expensive high-throughput DNA sequencing technologies has yielded a dramatic increase in the volume of sequence data that must be analyzed. These data are being generated for several purposes, including genotyping, genome resequencing, metagenomics, and de novo genome assembly projects. Sequence alignment programs such as MUMmer have proven essential for analysis of these data, but researchers will need ever faster, high-throughput alignment tools running on inexpensive hardware to keep up with new sequence technologies. Results This paper describes MUMmerGPU, an open-source high-throughput parallel pairwise local sequence alignment program that runs on commodity Graphics Processing Units (GPUs in common workstations. MUMmerGPU uses the new Compute Unified Device Architecture (CUDA from nVidia to align multiple query sequences against a single reference sequence stored as a suffix tree. By processing the queries in parallel on the highly parallel graphics card, MUMmerGPU achieves more than a 10-fold speedup over a serial CPU version of the sequence alignment kernel, and outperforms the exact alignment component of MUMmer on a high end CPU by 3.5-fold in total application time when aligning reads from recent sequencing projects using Solexa/Illumina, 454, and Sanger sequencing technologies. Conclusion MUMmerGPU is a low cost, ultra-fast sequence alignment program designed to handle the increasing volume of data produced by new, high-throughput sequencing technologies. MUMmerGPU demonstrates that even memory-intensive applications can run significantly faster on the relatively low-cost GPU than on the CPU.

  1. Data Parallel Line Relaxation (DPLR) Code User Manual: Acadia - Version 4.01.1

    Science.gov (United States)

    Wright, Michael J.; White, Todd; Mangini, Nancy

    2009-01-01

    Data-Parallel Line Relaxation (DPLR) code is a computational fluid dynamic (CFD) solver that was developed at NASA Ames Research Center to help mission support teams generate high-value predictive solutions for hypersonic flow field problems. The DPLR Code Package is an MPI-based, parallel, full three-dimensional Navier-Stokes CFD solver with generalized models for finite-rate reaction kinetics, thermal and chemical non-equilibrium, accurate high-temperature transport coefficients, and ionized flow physics incorporated into the code. DPLR also includes a large selection of generalized realistic surface boundary conditions and links to enable loose coupling with external thermal protection system (TPS) material response and shock layer radiation codes.

  2. Precision alignment device

    Science.gov (United States)

    Jones, N.E.

    1988-03-10

    Apparatus for providing automatic alignment of beam devices having an associated structure for directing, collimating, focusing, reflecting, or otherwise modifying the main beam. A reference laser is attached to the structure enclosing the main beam producing apparatus and produces a reference beam substantially parallel to the main beam. Detector modules containing optical switching devices and optical detectors are positioned in the path of the reference beam and are effective to produce an electrical output indicative of the alignment of the main beam. This electrical output drives servomotor operated adjustment screws to adjust the position of elements of the structure associated with the main beam to maintain alignment of the main beam. 5 figs.

  3. Modulations of the processing of line discontinuities under selective attention conditions?

    Science.gov (United States)

    Giersch, Anne; Fahle, Manfred

    2002-01-01

    We examined whether the processing of discontinuities involved in figure-ground segmentation, like line ends, can be modulated under selective attention conditions. Subjects decided whether a gap in collinear or parallel lines was located to the right or left. Two stimuli were displayed in immediate succession. When the gaps were on the same side, reaction times (RTs) for the second stimulus increased when collinear lines followed parallel lines, or the reverse, but only when the two stimuli shared the same orientation and location. The effect did not depend on the global form of the stimuli or on the relative orientation of the gaps. A frame drawn around collinear elements affected the results, suggesting a crucial role of the "amodal" orthogonal lines produced when line ends are aligned. Including several gaps in the first stimulus also eliminated RT variations. By contrast, RT variations remained stable across several experimental blocks and were significant for interstimulus intervals from 50 to 600 msec between the two stimuli. These results are interpreted in terms of a modulation of the processing of line ends or the production of amodal lines, arising when attention is selectively drawn to a gap.

  4. Simple and robust generation of ultrafast laser pulse trains using polarization-independent parallel-aligned thin films

    Science.gov (United States)

    Wang, Andong; Jiang, Lan; Li, Xiaowei; Wang, Zhi; Du, Kun; Lu, Yongfeng

    2018-05-01

    Ultrafast laser pulse temporal shaping has been widely applied in various important applications such as laser materials processing, coherent control of chemical reactions, and ultrafast imaging. However, temporal pulse shaping has been limited to only-in-lab technique due to the high cost, low damage threshold, and polarization dependence. Herein we propose a novel design of ultrafast laser pulse train generation device, which consists of multiple polarization-independent parallel-aligned thin films. Various pulse trains with controllable temporal profile can be generated flexibly by multi-reflections within the splitting films. Compared with other pulse train generation techniques, this method has advantages of compact structure, low cost, high damage threshold and polarization independence. These advantages endow it with high potential for broad utilization in ultrafast applications.

  5. PLAST: parallel local alignment search tool for database comparison

    Directory of Open Access Journals (Sweden)

    Lavenier Dominique

    2009-10-01

    Full Text Available Abstract Background Sequence similarity searching is an important and challenging task in molecular biology and next-generation sequencing should further strengthen the need for faster algorithms to process such vast amounts of data. At the same time, the internal architecture of current microprocessors is tending towards more parallelism, leading to the use of chips with two, four and more cores integrated on the same die. The main purpose of this work was to design an effective algorithm to fit with the parallel capabilities of modern microprocessors. Results A parallel algorithm for comparing large genomic banks and targeting middle-range computers has been developed and implemented in PLAST software. The algorithm exploits two key parallel features of existing and future microprocessors: the SIMD programming model (SSE instruction set and the multithreading concept (multicore. Compared to multithreaded BLAST software, tests performed on an 8-processor server have shown speedup ranging from 3 to 6 with a similar level of accuracy. Conclusion A parallel algorithmic approach driven by the knowledge of the internal microprocessor architecture allows significant speedup to be obtained while preserving standard sensitivity for similarity search problems.

  6. Line filter design of parallel interleaved VSCs for high power wind energy conversion systems

    DEFF Research Database (Denmark)

    Gohil, Ghanshyamsinh Vijaysinh; Bede, Lorand; Teodorescu, Remus

    2015-01-01

    The Voltage Source Converters (VSCs) are often connected in parallel in a Wind Energy Conversion System (WECS) to match the high power rating of the modern wind turbines. The effect of the interleaved carriers on the harmonic performance of the parallel connected VSCs is analyzed in this paper...... limit. In order to achieve the desired filter performance with optimal values of the filter parameters, the use of a LC trap branch with the conventional LCL filter is proposed. The expressions for the resonant frequencies of the proposed line filter are derived and used in the design to selectively...

  7. Effect of alignment of easy axes on dynamic magnetization of immobilized magnetic nanoparticles

    Science.gov (United States)

    Yoshida, Takashi; Matsugi, Yuki; Tsujimura, Naotaka; Sasayama, Teruyoshi; Enpuku, Keiji; Viereck, Thilo; Schilling, Meinhard; Ludwig, Frank

    2017-04-01

    In some biomedical applications of magnetic nanoparticles (MNPs), the particles are physically immobilized. In this study, we explore the effect of the alignment of the magnetic easy axes on the dynamic magnetization of immobilized MNPs under an AC excitation field. We prepared three immobilized MNP samples: (1) a sample in which easy axes are randomly oriented, (2) a parallel-aligned sample in which easy axes are parallel to the AC field, and (3) an orthogonally aligned sample in which easy axes are perpendicular to the AC field. First, we show that the parallel-aligned sample has the largest hysteresis in the magnetization curve and the largest harmonic magnetization spectra, followed by the randomly oriented and orthogonally aligned samples. For example, 1.6-fold increase was observed in the area of the hysteresis loop of the parallel-aligned sample compared to that of the randomly oriented sample. To quantitatively discuss the experimental results, we perform a numerical simulation based on a Fokker-Planck equation, in which probability distributions for the directions of the easy axes are taken into account in simulating the prepared MNP samples. We obtained quantitative agreement between experiment and simulation. These results indicate that the dynamic magnetization of immobilized MNPs is significantly affected by the alignment of the easy axes.

  8. Model-driven product line engineering for mapping parallel algorithms to parallel computing platforms

    NARCIS (Netherlands)

    Arkin, Ethem; Tekinerdogan, Bedir

    2016-01-01

    Mapping parallel algorithms to parallel computing platforms requires several activities such as the analysis of the parallel algorithm, the definition of the logical configuration of the platform, the mapping of the algorithm to the logical configuration platform and the implementation of the

  9. Sample size effect on the determination of the irreversibility line of high-Tc superconductors

    International Nuclear Information System (INIS)

    Li, Q.; Suenaga, M.; Li, Q.; Freltoft, T.

    1994-01-01

    The irreversibility lines of a high-J c superconducting Bi 2 Sr 2 Ca 2 Cu 3 O x /Ag tape were systematically measured upon a sequence of subdivisions of the sample. The irreversibility field H r (T) (parallel to the c axis) was found to change approximately as L 0.13 , where L is the effective dimension of the superconducting tape. Furthermore, it was found that the irreversibility line for a grain-aligned Bi 2 Sr 2 Ca 2 Cu 3 O x specimen can be approximately reproduced by the extrapolation of this relation down to a grain size of a few tens of micrometers. The observed size effect could significantly obscure the real physical meaning of the irreversibility lines. In addition, this finding surprisingly indicated that the Bi 2 Sr 2 Ca 2 Cu 2 O x /Ag tape and grain-aligned specimen may have similar flux line pinning strength

  10. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez

    2010-01-01

    Most of the work in muon alignment since December 2009 has focused on the geometry reconstruction from the optical systems and improvements in the internal alignment of the DT chambers. The barrel optical alignment system has progressively evolved from reconstruction of single active planes to super-planes (December 09) to a new, full barrel reconstruction. Initial validation studies comparing this full barrel alignment at 0T with photogrammetry provide promising results. In addition, the method has been applied to CRAFT09 data, and the resulting alignment at 3.8T yields residuals from tracks (extrapolated from the tracker) which look smooth, suggesting a good internal barrel alignment with a small overall offset with respect to the tracker. This is a significant improvement, which should allow the optical system to provide a start-up alignment for 2010. The end-cap optical alignment has made considerable progress in the analysis of transfer line data. The next set of alignment constants for CSCs will there...

  11. Microwave and Millimeter Wave Properties of Vertically-Aligned Single Wall Carbon Nanotubes Films

    Science.gov (United States)

    Haddadi, K.; Tripon-Canseliet, C.; Hivin, Q.; Ducournau, G.; Teo, E.; Coquet, P.; Tay, B. K.; Lepilliet, S.; Avramovic, V.; Chazelas, J.; Decoster, D.

    2016-05-01

    We present the experimental determination of the complex permittivity of vertically aligned single wall carbon nanotubes (SWCNTs) films grown on quartz substrates in the microwave regime from 10 MHz up to 67 GHz, with the electrical field perpendicular to the main axis of the carbon nanotubes (CNTs), based on coplanar waveguide transmission line approach together with the measurement of the microwave impedance of top metalized vertically—aligned SWCNTs grown on conductive silicon substrates up to 26 GHz. From coplanar waveguide measurements, we obtain a real part of the permittivity almost equal to unity, which is interpreted in terms of low carbon atom density (3 × 1019 at/cm3) associated with a very low imaginary part of permittivity (vertically aligned CNTs bundle equivalent to a low resistance reveals a good conductivity (3 S/cm) parallel to the CNTs axis. From these two kinds of data, we experimentally demonstrate the tensor nature of the vertically grown CNTs bundles.

  12. Incorporation of parallel electrospun fibers for improved topographical guidance in 3D nerve guides

    International Nuclear Information System (INIS)

    Jeffries, Eric M; Wang Yadong

    2013-01-01

    Three dimensional (3D) conduits facilitate nerve regeneration. Parallel microfibers have been shown to guide axon extension and Schwann cell migration on flat sheets via topographical cues. However, incorporation of aligned microfibers into 3D conduits to accelerate nerve regeneration has proven challenging. We report an electrospinning technique to incorporate parallel microfibers into 3D constructs at high surface areas while retaining an open architecture. The nerve guide consists of many microchannels lined with a thin layer of longitudinally-aligned microfibers. This design aims to maximize benefits of topographical cues without inhibiting cellular infiltration. We support this hypothesis by demonstrating efficient cell infiltration in vitro. Additionally, this new technique reduces wall thickness compared to our previous design, providing a greater total area for tissue growth. This approach results in an architecture that very closely mimics the structure of decellularized nerve but with larger microchannel diameters to encourage cell infiltration. We believe that reproducing the native architecture is the first step toward matching autograph efficacy. Furthermore, this design can be combined with other biochemical cues to promote nerve regeneration. (paper)

  13. BarraCUDA - a fast short read sequence aligner using graphics processing units

    Directory of Open Access Journals (Sweden)

    Klus Petr

    2012-01-01

    Full Text Available Abstract Background With the maturation of next-generation DNA sequencing (NGS technologies, the throughput of DNA sequencing reads has soared to over 600 gigabases from a single instrument run. General purpose computing on graphics processing units (GPGPU, extracts the computing power from hundreds of parallel stream processors within graphics processing cores and provides a cost-effective and energy efficient alternative to traditional high-performance computing (HPC clusters. In this article, we describe the implementation of BarraCUDA, a GPGPU sequence alignment software that is based on BWA, to accelerate the alignment of sequencing reads generated by these instruments to a reference DNA sequence. Findings Using the NVIDIA Compute Unified Device Architecture (CUDA software development environment, we ported the most computational-intensive alignment component of BWA to GPU to take advantage of the massive parallelism. As a result, BarraCUDA offers a magnitude of performance boost in alignment throughput when compared to a CPU core while delivering the same level of alignment fidelity. The software is also capable of supporting multiple CUDA devices in parallel to further accelerate the alignment throughput. Conclusions BarraCUDA is designed to take advantage of the parallelism of GPU to accelerate the alignment of millions of sequencing reads generated by NGS instruments. By doing this, we could, at least in part streamline the current bioinformatics pipeline such that the wider scientific community could benefit from the sequencing technology. BarraCUDA is currently available from http://seqbarracuda.sf.net

  14. BarraCUDA - a fast short read sequence aligner using graphics processing units

    LENUS (Irish Health Repository)

    Klus, Petr

    2012-01-13

    Abstract Background With the maturation of next-generation DNA sequencing (NGS) technologies, the throughput of DNA sequencing reads has soared to over 600 gigabases from a single instrument run. General purpose computing on graphics processing units (GPGPU), extracts the computing power from hundreds of parallel stream processors within graphics processing cores and provides a cost-effective and energy efficient alternative to traditional high-performance computing (HPC) clusters. In this article, we describe the implementation of BarraCUDA, a GPGPU sequence alignment software that is based on BWA, to accelerate the alignment of sequencing reads generated by these instruments to a reference DNA sequence. Findings Using the NVIDIA Compute Unified Device Architecture (CUDA) software development environment, we ported the most computational-intensive alignment component of BWA to GPU to take advantage of the massive parallelism. As a result, BarraCUDA offers a magnitude of performance boost in alignment throughput when compared to a CPU core while delivering the same level of alignment fidelity. The software is also capable of supporting multiple CUDA devices in parallel to further accelerate the alignment throughput. Conclusions BarraCUDA is designed to take advantage of the parallelism of GPU to accelerate the alignment of millions of sequencing reads generated by NGS instruments. By doing this, we could, at least in part streamline the current bioinformatics pipeline such that the wider scientific community could benefit from the sequencing technology. BarraCUDA is currently available from http:\\/\\/seqbarracuda.sf.net

  15. Line-plane broadcasting in a data communications network of a parallel computer

    Science.gov (United States)

    Archer, Charles J.; Berg, Jeremy E.; Blocksome, Michael A.; Smith, Brian E.

    2010-06-08

    Methods, apparatus, and products are disclosed for line-plane broadcasting in a data communications network of a parallel computer, the parallel computer comprising a plurality of compute nodes connected together through the network, the network optimized for point to point data communications and characterized by at least a first dimension, a second dimension, and a third dimension, that include: initiating, by a broadcasting compute node, a broadcast operation, including sending a message to all of the compute nodes along an axis of the first dimension for the network; sending, by each compute node along the axis of the first dimension, the message to all of the compute nodes along an axis of the second dimension for the network; and sending, by each compute node along the axis of the second dimension, the message to all of the compute nodes along an axis of the third dimension for the network.

  16. Alignments of the galaxies in and around the Virgo cluster with the local velocity shear

    International Nuclear Information System (INIS)

    Lee, Jounghun; Rey, Soo Chang; Kim, Suk

    2014-01-01

    Observational evidence is presented for the alignment between the cosmic sheet and the principal axis of the velocity shear field at the position of the Virgo cluster. The galaxies in and around the Virgo cluster from the Extended Virgo Cluster Catalog that was recently constructed by Kim et al. are used to determine the direction of the local sheet. The peculiar velocity field reconstructed from the Sloan Digital Sky Survey Data Release 7 is analyzed to estimate the local velocity shear tensor at the Virgo center. Showing first that the minor principal axis of the local velocity shear tensor is almost parallel to the direction of the line of sight, we detect a clear signal of alignment between the positions of the Virgo satellites and the intermediate principal axis of the local velocity shear projected onto the plane of the sky. Furthermore, the dwarf satellites are found to appear more strongly aligned than their normal counterparts, which is interpreted as an indication of the following. (1) The normal satellites and the dwarf satellites fall in the Virgo cluster preferentially along the local filament and the local sheet, respectively. (2) The local filament is aligned with the minor principal axis of the local velocity shear while the local sheet is parallel to the plane spanned by the minor and intermediate principal axes. Our result is consistent with the recent numerical claim that the velocity shear is a good tracer of the cosmic web.

  17. Transmission line theory for long plasma production by radio frequency discharges between parallel-plate electrodes

    International Nuclear Information System (INIS)

    Nonaka, S.

    1991-01-01

    In order to seek for a radio frequency (RF) eigen-mode of waves in producing a plasma between a pair of long dielectric-covered parallel-plate RF electrodes, this paper analyzed all normal modes propagating along the electrodes by solving Maxwell's equations. The result showed that only an odd surface wave mode will produce the plasma in usual experimental conditions, which will become a basic transmission line theory when use of such long electrodes for on-line mass-production of amorphous silicon solar cells

  18. Liquid crystallinity driven highly aligned large graphene oxide composites

    Energy Technology Data Exchange (ETDEWEB)

    Lee, Kyung Eun; Oh, Jung Jae; Yun, Taeyeong [Center for Nanomaterials and Chemical Reactions, Institute for Basic Science (IBS), Daejeon 305-701 (Korea, Republic of); Department of Chemistry, Korea Advanced Institute of Science and Technology (KAIST), Daejeon 305-701 (Korea, Republic of); Kim, Sang Ouk, E-mail: sangouk.kim@kaist.ac.kr [Center for Nanomaterials and Chemical Reactions, Institute for Basic Science (IBS), Daejeon 305-701 (Korea, Republic of); Department of Chemistry, Korea Advanced Institute of Science and Technology (KAIST), Daejeon 305-701 (Korea, Republic of)

    2015-04-15

    Graphene is an emerging graphitic carbon materials, consisting of sp{sup 2} hybridized two dimensinal honeycomb structure. It has been widely studied to incorporate graphene with polymer to utilize unique property of graphene and reinforce electrical, mechanical and thermal property of polymer. In composite materials, orientation control of graphene significantly influences the property of composite. Until now, a few method has been developed for orientation control of graphene within polymer matrix. Here, we demonstrate facile fabrication of high aligned large graphene oxide (LGO) composites in polydimethylsiloxane (PDMS) matrix exploiting liquid crystallinity. Liquid crystalline aqueous dispersion of LGO is parallel oriented within flat confinement geometry. Freeze-drying of the aligned LGO dispersion and subsequent infiltration with PDMS produce highly aligned LGO/PDMS composites. Owing to the large shape anisotropy of LGO, liquid crystalline alignment occurred at low concentration of 2 mg/ml in aqueous dispersion, which leads to the 0.2 wt% LGO loaded composites. - Graphical abstract: Liquid crystalline LGO aqueous dispersions are spontaneous parallel aligned between geometric confinement for highly aligned LGO/polymer composite fabrication. - Highlights: • A simple fabrication method for highly aligned LGO/PDMS composites is proposed. • LGO aqueous dispersion shows nematic liquid crystalline phase at 0.8 mg/ml. • In nematic phase, LGO flakes are highly aligned by geometric confinement. • Infiltration of PDMS into freeze-dried LGO allows highly aligned LGO/PDMS composites.

  19. An Alignment of J-PARC Linac

    CERN Document Server

    Morishita, Takatoshi; Hasegawa, Kazuo; Ikegami, Masanori; Ito, Takashi; Kubota, Chikashi; Naito, Fujio; Takasaki, Eiichi; Tanaka, Hirokazu; Ueno, Akira; Yoshino, Kazuo

    2005-01-01

    J-PARC linear accelerator components are now being installed in the accelerator tunnel, whose total length is more than 400 m including the beam transport line to RCS (Rapid Cycling Synchrotron). A precise alignment of accelerator components is essential for a high quality beam acceleration. In this paper, planned alignment schemes for the installation of linac components, the fine alignment before beam acceleration, and watching the long term motion of the building are described. Guide points are placed on the floor, which acts as a reference for the initial alignment at the installation and also as a relay point for the long surveying network linking at the fine alignment. For a straight line alignment, the wire position sensor is placed on the offset position with respect to the beam center by a target holder, then a single wire can cover the accelerator cavities and the focusing magnets at the DTL-SDTL section (120m). The hydrostatic levering system (HLS) is used for watching the floor elevation (changes)...

  20. A study of parallelism of the occlusal plane and ala-tragus line.

    Science.gov (United States)

    Sadr, Katayoun; Sadr, Makan

    2009-01-01

    Orientation of the occlusal plane is one of the most important clinical procedures in prostho-dontic rehabilitation of edentulous patients. The aim of this study was to define the best posterior reference point of ala-tragus line for orientation of occlusal plane for complete denture fabrication. Fifty-three dental students (27 females and 26 males) with complete natural dentition and Angel's Class I occlusal relationship were selected. The subjects were photographed in natural head position while clenching on a Fox plane. After tracing the photographs, the angles between the following lines were measured: the occlusal plane (Fox plane) and the superior border of ala-tragus, the occlusal plane (Fox plane) and the middle of ala-tragus as well as the occlusal plane (Fox plane) and the inferior border of ala-tragus. Descriptive statistics, one sample t-test and independent t-test were used. P value less than 0.05 was considered significant. There was no parallelism between the occlusal plane and ala-tragus line with three different posterior ends and one sample t-test showed that the angles between them were significantly different from zero (pplane. The superior border of the tragus is suggested as the posterior reference for ala-tragus line.

  1. Wideband Dual-Polarization Patch Antenna Array With Parallel Strip Line Balun Feeding

    DEFF Research Database (Denmark)

    Zhang, Jin; Lin, Xianqi; Nie, Liying

    2016-01-01

    A wideband dual-polarization patch antenna array is proposed in this letter. The array is fed by a parallel strip line balun, which is adopted to generate 180° phase shift in a wide frequency range. In addition, this balun has simple structure, very small phase shift error, and good ports isolati...... is higher than 30 dB. The simulation and measurement turns out to be similar. This antenna array can be used in TD-LTE base stations, and the design methods are also useful to other wideband microstrip antennas....

  2. Parallel implementation of the PHOENIX generalized stellar atmosphere program. II. Wavelength parallelization

    International Nuclear Information System (INIS)

    Baron, E.; Hauschildt, Peter H.

    1998-01-01

    We describe an important addition to the parallel implementation of our generalized nonlocal thermodynamic equilibrium (NLTE) stellar atmosphere and radiative transfer computer program PHOENIX. In a previous paper in this series we described data and task parallel algorithms we have developed for radiative transfer, spectral line opacity, and NLTE opacity and rate calculations. These algorithms divided the work spatially or by spectral lines, that is, distributing the radial zones, individual spectral lines, or characteristic rays among different processors and employ, in addition, task parallelism for logically independent functions (such as atomic and molecular line opacities). For finite, monotonic velocity fields, the radiative transfer equation is an initial value problem in wavelength, and hence each wavelength point depends upon the previous one. However, for sophisticated NLTE models of both static and moving atmospheres needed to accurately describe, e.g., novae and supernovae, the number of wavelength points is very large (200,000 - 300,000) and hence parallelization over wavelength can lead both to considerable speedup in calculation time and the ability to make use of the aggregate memory available on massively parallel supercomputers. Here, we describe an implementation of a pipelined design for the wavelength parallelization of PHOENIX, where the necessary data from the processor working on a previous wavelength point is sent to the processor working on the succeeding wavelength point as soon as it is known. Our implementation uses a MIMD design based on a relatively small number of standard message passing interface (MPI) library calls and is fully portable between serial and parallel computers. copyright 1998 The American Astronomical Society

  3. Parallel superconducting strip-line detectors: reset behaviour in the single-strip switch regime

    International Nuclear Information System (INIS)

    Casaburi, A; Heath, R M; Tanner, M G; Hadfield, R H; Cristiano, R; Ejrnaes, M; Nappi, C

    2014-01-01

    Superconducting strip-line detectors (SSLDs) are an important emerging technology for the detection of single molecules in time-of-flight mass spectrometry (TOF-MS). We present an experimental investigation of a SSLD laid out in a parallel configuration, designed to address selected single strip-lines operating in the single-strip switch regime. Fast laser pulses were tightly focused onto the device, allowing controllable nucleation of a resistive region at a specific location and study of the subsequent device response dynamics. We observed that in this regime, although the strip-line returns to the superconducting state after triggering, no effective recovery of the bias current occurs, in qualitative agreement with a phenomenological circuit simulation that we performed. Moreover, from theoretical considerations and by looking at the experimental pulse amplitude distribution histogram, we have the first confirmation of the fact that the phenomenological London model governs the current redistribution in these large area devices also after detection events. (paper)

  4. Generic accelerated sequence alignment in SeqAn using vectorization and multi-threading.

    Science.gov (United States)

    Rahn, René; Budach, Stefan; Costanza, Pascal; Ehrhardt, Marcel; Hancox, Jonny; Reinert, Knut

    2018-05-03

    Pairwise sequence alignment is undoubtedly a central tool in many bioinformatics analyses. In this paper, we present a generically accelerated module for pairwise sequence alignments applicable for a broad range of applications. In our module, we unified the standard dynamic programming kernel used for pairwise sequence alignments and extended it with a generalized inter-sequence vectorization layout, such that many alignments can be computed simultaneously by exploiting SIMD (Single Instruction Multiple Data) instructions of modern processors. We then extended the module by adding two layers of thread-level parallelization, where we a) distribute many independent alignments on multiple threads and b) inherently parallelize a single alignment computation using a work stealing approach producing a dynamic wavefront progressing along the minor diagonal. We evaluated our alignment vectorization and parallelization on different processors, including the newest Intel® Xeon® (Skylake) and Intel® Xeon Phi™ (KNL) processors, and use cases. The instruction set AVX512-BW (Byte and Word), available on Skylake processors, can genuinely improve the performance of vectorized alignments. We could run single alignments 1600 times faster on the Xeon Phi™ and 1400 times faster on the Xeon® than executing them with our previous sequential alignment module. The module is programmed in C++ using the SeqAn (Reinert et al., 2017) library and distributed with version 2.4. under the BSD license. We support SSE4, AVX2, AVX512 instructions and included UME::SIMD, a SIMD-instruction wrapper library, to extend our module for further instruction sets. We thoroughly test all alignment components with all major C++ compilers on various platforms. rene.rahn@fu-berlin.de.

  5. pyPaSWAS: Python-based multi-core CPU and GPU sequence alignment.

    Science.gov (United States)

    Warris, Sven; Timal, N Roshan N; Kempenaar, Marcel; Poortinga, Arne M; van de Geest, Henri; Varbanescu, Ana L; Nap, Jan-Peter

    2018-01-01

    Our previously published CUDA-only application PaSWAS for Smith-Waterman (SW) sequence alignment of any type of sequence on NVIDIA-based GPUs is platform-specific and therefore adopted less than could be. The OpenCL language is supported more widely and allows use on a variety of hardware platforms. Moreover, there is a need to promote the adoption of parallel computing in bioinformatics by making its use and extension more simple through more and better application of high-level languages commonly used in bioinformatics, such as Python. The novel application pyPaSWAS presents the parallel SW sequence alignment code fully packed in Python. It is a generic SW implementation running on several hardware platforms with multi-core systems and/or GPUs that provides accurate sequence alignments that also can be inspected for alignment details. Additionally, pyPaSWAS support the affine gap penalty. Python libraries are used for automated system configuration, I/O and logging. This way, the Python environment will stimulate further extension and use of pyPaSWAS. pyPaSWAS presents an easy Python-based environment for accurate and retrievable parallel SW sequence alignments on GPUs and multi-core systems. The strategy of integrating Python with high-performance parallel compute languages to create a developer- and user-friendly environment should be considered for other computationally intensive bioinformatics algorithms.

  6. Reducing beam shaper alignment complexity: diagnostic techniques for alignment and tuning

    Science.gov (United States)

    Lizotte, Todd E.

    2011-10-01

    Safe and efficient optical alignment is a critical requirement for industrial laser systems used in a high volume manufacturing environment. Of specific interest is the development of techniques to align beam shaping optics within a beam line; having the ability to instantly verify by a qualitative means that each element is in its proper position as the beam shaper module is being aligned. There is a need to reduce these types of alignment techniques down to a level where even a newbie to optical alignment will be able to complete the task. Couple this alignment need with the fact that most laser system manufacturers ship their products worldwide and the introduction of a new set of variables including cultural and language barriers, makes this a top priority for manufacturers. Tools and methodologies for alignment of complex optical systems need to be able to cross these barriers to ensure the highest degree of up time and reduce the cost of maintenance on the production floor. Customers worldwide, who purchase production laser equipment, understand that the majority of costs to a manufacturing facility is spent on system maintenance and is typically the largest single controllable expenditure in a production plant. This desire to reduce costs is driving the trend these days towards predictive and proactive, not reactive maintenance of laser based optical beam delivery systems [10]. With proper diagnostic tools, laser system developers can develop proactive approaches to reduce system down time, safe guard operational performance and reduce premature or catastrophic optics failures. Obviously analytical data will provide quantifiable performance standards which are more precise than qualitative standards, but each have a role in determining overall optical system performance [10]. This paper will discuss the use of film and fluorescent mirror devices as diagnostic tools for beam shaper module alignment off line or in-situ. The paper will also provide an overview

  7. Preparation and Characterization of Highly Aligned Carbon Nanotubes/Polyacrylonitrile Composite Nanofibers

    Directory of Open Access Journals (Sweden)

    Yanhua Song

    2017-01-01

    Full Text Available In the electrospinning process, a modified parallel electrode method (MPEM, conducted by placing a positively charged ring between the needle and the parallel electrode collector, was used to fabricate highly aligned carbon nanotubes/polyacrylonitrile (CNTs/PAN composite nanofibers. Characterizations of the samples—such as morphology, the degree of alignment, and mechanical and conductive properties—were investigated by a combination of scanning electron microscopy (SEM, transmission electron microscopy (TEM, universal testing machine, high-resistance meter, and other methods. The results showed the MPEM could improve the alignment and uniformity of electrospun CNTs/PAN composite nanofibers, and enhance their mechanical and conductive properties. This meant the successful preparation of highly aligned CNT-reinforced PAN nanofibers with enhanced physical properties, suggesting their potential application in appliances and communication areas.

  8. Assembly and Alignment of Ship Power Plants in Modern Shipbuilding

    OpenAIRE

    A. O. Mikhailov; K. N. Morozov

    2013-01-01

    Fine alignment of main ship power plants mechanisms and shaft lines provides long-term and failure-free performance of propulsion system while fast and high-quality installation of mechanisms and shaft lines decreases common labor intensity. For checking shaft line allowed stress and setting its alignment it is required to perform calculations considering various stages of life cycle. In 2012 JSC SSTC developed special software complex “Shaftline” for calculation of align...

  9. Parallelism at Cern: real-time and off-line applications in the GP-MIMD2 project

    International Nuclear Information System (INIS)

    Calafiura, P.

    1997-01-01

    A wide range of general purpose high-energy physics applications, ranging from Monte Carlo simulation to data acquisition, from interactive data analysis to on-line filtering, have been ported, or developed, and run in parallel on IBM SP-2 and Meiko CS-2 CERN large multi-processor machines. The ESPRIT project GP-MIMD2 has been a catalyst for the interest in parallel computing at CERN. The project provided the 128 processor Meiko CS-2 system that is now succesfully integrated in the CERN computing environment. The CERN experiment NA48 was involved in the GP-MIMD2 project since the beginning. NA48 physicists run, as part of their day-to-day work, simulation and analysis programs parallelized using the message passing interface MPI. The CS-2 is also a vital component of the experiment data acquisition system and will be used to calibrate in real-time the 13000 channels liquid krypton calorimeter. (orig.)

  10. Propagation and stability characteristics of a 500-m-long laser-based fiducial line for high-precision alignment of long-distance linear accelerators.

    Science.gov (United States)

    Suwada, Tsuyoshi; Satoh, Masanori; Telada, Souichi; Minoshima, Kaoru

    2013-09-01

    A laser-based alignment system with a He-Ne laser has been newly developed in order to precisely align accelerator units at the KEKB injector linac. The laser beam was first implemented as a 500-m-long fiducial straight line for alignment measurements. We experimentally investigated the propagation and stability characteristics of the laser beam passing through laser pipes in vacuum. The pointing stability at the last fiducial point was successfully obtained with the transverse displacements of ±40 μm level in one standard deviation by applying a feedback control. This pointing stability corresponds to an angle of ±0.08 μrad. This report contains a detailed description of the experimental investigation for the propagation and stability characteristics of the laser beam in the laser-based alignment system for long-distance linear accelerators.

  11. Pattern-Driven Automatic Parallelization

    Directory of Open Access Journals (Sweden)

    Christoph W. Kessler

    1996-01-01

    Full Text Available This article describes a knowledge-based system for automatic parallelization of a wide class of sequential numerical codes operating on vectors and dense matrices, and for execution on distributed memory message-passing multiprocessors. Its main feature is a fast and powerful pattern recognition tool that locally identifies frequently occurring computations and programming concepts in the source code. This tool also works for dusty deck codes that have been "encrypted" by former machine-specific code transformations. Successful pattern recognition guides sophisticated code transformations including local algorithm replacement such that the parallelized code need not emerge from the sequential program structure by just parallelizing the loops. It allows access to an expert's knowledge on useful parallel algorithms, available machine-specific library routines, and powerful program transformations. The partially restored program semantics also supports local array alignment, distribution, and redistribution, and allows for faster and more exact prediction of the performance of the parallelized target code than is usually possible.

  12. The magnetic properties of aligned M hexa-ferrite fibres

    International Nuclear Information System (INIS)

    Pullar, R.C.; Bhattacharya, A.K.

    2006-01-01

    Aligned and random fibres of strontium hexa ferrite (SrM, SrFe 12 O 19 ) and barium hexaferrite (BaM, BaFe 12 O 19 ) were manufactured by blow spinning from an aqueous inorganic sol-gel precursor, which was then fired to give the hexagonal ferrite fibre. Their magnetic properties were studied by VSM, investigating the evolution of these properties with firing and measurement temperature, and in particular the effects of fibre alignment. It has been predicted that aligned ferrite fibres will demonstrate an enhanced magnetisation along the axis of alignment with respect to perpendicular to the axis, and this has been demonstrated here for the first time. The optimum firing temperature was 1000 deg. C, at which point they still had submicron grains. In BaM random fibres M s =63.8 emu g -1 and H c =428.1 kA m -1 , and in SrM random fibres M s =63.3 emu g -1 and H c =452.8 kA m -1 , high values for polycrystalline materials. Fibres aligned parallel to the applied field had saturation magnetisation (M s ) values equal to those of the random fibres, whilst fibres aligned perpendicular to the field had M s values 62% and 75% lower, for BaM and SrM, respectively. There was no change in coercivity (H c ) between random or aligned fibres of any orientation, and fibres aligned 45 deg. and parallel to H appeared identical. Therefore, properties along the axis of alignment were superior when compared to measurements perpendicular to the axis of alignment, giving a directionality to the magnetisation in an otherwise randomly oriented ferrite material

  13. Genomic multiple sequence alignments: refinement using a genetic algorithm

    Directory of Open Access Journals (Sweden)

    Lefkowitz Elliot J

    2005-08-01

    Full Text Available Abstract Background Genomic sequence data cannot be fully appreciated in isolation. Comparative genomics – the practice of comparing genomic sequences from different species – plays an increasingly important role in understanding the genotypic differences between species that result in phenotypic differences as well as in revealing patterns of evolutionary relationships. One of the major challenges in comparative genomics is producing a high-quality alignment between two or more related genomic sequences. In recent years, a number of tools have been developed for aligning large genomic sequences. Most utilize heuristic strategies to identify a series of strong sequence similarities, which are then used as anchors to align the regions between the anchor points. The resulting alignment is globally correct, but in many cases is suboptimal locally. We describe a new program, GenAlignRefine, which improves the overall quality of global multiple alignments by using a genetic algorithm to improve local regions of alignment. Regions of low quality are identified, realigned using the program T-Coffee, and then refined using a genetic algorithm. Because a better COFFEE (Consistency based Objective Function For alignmEnt Evaluation score generally reflects greater alignment quality, the algorithm searches for an alignment that yields a better COFFEE score. To improve the intrinsic slowness of the genetic algorithm, GenAlignRefine was implemented as a parallel, cluster-based program. Results We tested the GenAlignRefine algorithm by running it on a Linux cluster to refine sequences from a simulation, as well as refine a multiple alignment of 15 Orthopoxvirus genomic sequences approximately 260,000 nucleotides in length that initially had been aligned by Multi-LAGAN. It took approximately 150 minutes for a 40-processor Linux cluster to optimize some 200 fuzzy (poorly aligned regions of the orthopoxvirus alignment. Overall sequence identity increased only

  14. Plans for PEP survey and alignment: Status report

    International Nuclear Information System (INIS)

    Gunn, J.; Sah, R.

    1975-01-01

    This note discusses the current state of survey and alignment plans for PEP Stage I. Several surveying techniques are described; one is described in considerable detail. The survey and alignment task for PEP consists of positioning approximately 700 ring magnets, 100 injection line magnets, and 100 miscellaneous components. The alignment tolerances are tight and they are set by the requirement that closed orbit distortions must be small for proper storage ring operation. The alignment problem is aggravated by the circumstance that the storage ring components are placed in tunnels which span a large area (over 700 meters across) and which do not permit long lines of sight. 6 ref., 1 fig

  15. Alignment of CEBAF cryomodules

    International Nuclear Information System (INIS)

    Schneider, W.J.; Bisognano, J.J.; Fischer, J.

    1993-06-01

    CEBAF, the Continuous Electron Beam Accelerator Facility, when completed, will house a 4 GeV recirculating accelerator. Each of the accelerator's two linacs contains 160 superconducting radio frequency (SRF) 1497 MHz niobium cavities in 20 cryomodules. Alignments of the cavities within the cryomodule with respect to beam axis is critical to achieving the optimum accelerator performance. This paper discusses the rationale for the current specification on cavity mechanical alignment: 2 mrad (rms) applied to the 0.5 m active length cavities. We describe the tooling that was developed to achieve the tolerance at the time of cavity pair assembly, to preserve and integrate alignment during cryomodule assembly, and to translate alignment to appropriate installation in the beam line

  16. Electrospun nanofiber reinforcement of dental composites with electromagnetic alignment approach

    International Nuclear Information System (INIS)

    Uyar, Tansel; Çökeliler, Dilek; Doğan, Mustafa; Koçum, Ismail Cengiz; Karatay, Okan; Denkbaş, Emir Baki

    2016-01-01

    Polymethylmethacrylate (PMMA) is commonly used as a base acrylic denture material with benefits of rapid and easy handling, however, when it is used in prosthetic dentistry, fracturing or cracking problems can be seen due to the relatively low strength issues. Besides, acrylic resin is the still prominent material for denture fabrication due to its handy and low cost features. Numerous proposed fillers that are used to produce PMMA composites, however electrospun polyvinylalcohol (PVA) nanofiber fillers for production of PMMA composite resins are not studied as much as the others. The other focus of the practice is to compare both mechanical properties and efficiency of aligned fibers versus non-aligned PVA nanofibers in PMMA based dental composites. Field-controlled electrospinning system is manufactured and provided good alignment in lab scale as one of contributions. Some novel auxiliary electrodes in controlled structure are augmented to obtain different patterns of alignment with a certain range of fiber diameters. Scanning electron microscopy is used for physical characterization to determine the range of fiber diameters. Non-woven fiber has no unique pattern due to chaotic nature of electrospinning process, but aligned fibers have round pattern or crossed lines. These produced fibers are structured as layer-by-layer form with different features, and these features are used in producing PMMA dental composites with different volume ratios. The maximum flexural strength figure shows that fiber load by weight of 0.25% w/w and above improves in the maximum level. As a result, mechanical properties of PMMA dental composites are improved by using PVA nanofibers as a filler, however the improvement was higher when aligned PVA nanofibers are used. The maximum values were 5.1 MPa (flexural strength), 0.8 GPa (elastic modulus), and 170 kJ/m 3 (toughness) in three-point bending test. In addition to the positive results of aligned and non-aligned nanofibers it was found

  17. Electrospun nanofiber reinforcement of dental composites with electromagnetic alignment approach

    Energy Technology Data Exchange (ETDEWEB)

    Uyar, Tansel [Department of Biomedical Engineering, Başkent University Bağlıca Campus, 06530 Ankara (Turkey); Çökeliler, Dilek, E-mail: cokeliler@baskent.edu.tr [Department of Biomedical Engineering, Başkent University Bağlıca Campus, 06530 Ankara (Turkey); Doğan, Mustafa [Department of Electrical and Electronics Engineering, Başkent University, Ankara 06180 (Turkey); Koçum, Ismail Cengiz [Department of Biomedical Engineering, Başkent University Bağlıca Campus, 06530 Ankara (Turkey); Karatay, Okan [Department of Electrical and Electronics Engineering, Başkent University, Ankara 06180 (Turkey); Denkbaş, Emir Baki [Department of Chemistry, Biochemistry Division, Hacettepe University, Ankara (Turkey)

    2016-05-01

    Polymethylmethacrylate (PMMA) is commonly used as a base acrylic denture material with benefits of rapid and easy handling, however, when it is used in prosthetic dentistry, fracturing or cracking problems can be seen due to the relatively low strength issues. Besides, acrylic resin is the still prominent material for denture fabrication due to its handy and low cost features. Numerous proposed fillers that are used to produce PMMA composites, however electrospun polyvinylalcohol (PVA) nanofiber fillers for production of PMMA composite resins are not studied as much as the others. The other focus of the practice is to compare both mechanical properties and efficiency of aligned fibers versus non-aligned PVA nanofibers in PMMA based dental composites. Field-controlled electrospinning system is manufactured and provided good alignment in lab scale as one of contributions. Some novel auxiliary electrodes in controlled structure are augmented to obtain different patterns of alignment with a certain range of fiber diameters. Scanning electron microscopy is used for physical characterization to determine the range of fiber diameters. Non-woven fiber has no unique pattern due to chaotic nature of electrospinning process, but aligned fibers have round pattern or crossed lines. These produced fibers are structured as layer-by-layer form with different features, and these features are used in producing PMMA dental composites with different volume ratios. The maximum flexural strength figure shows that fiber load by weight of 0.25% w/w and above improves in the maximum level. As a result, mechanical properties of PMMA dental composites are improved by using PVA nanofibers as a filler, however the improvement was higher when aligned PVA nanofibers are used. The maximum values were 5.1 MPa (flexural strength), 0.8 GPa (elastic modulus), and 170 kJ/m{sup 3} (toughness) in three-point bending test. In addition to the positive results of aligned and non-aligned nanofibers it was

  18. A Cassie-Like Law Using Triple Phase Boundary Line Fractions for Faceted Droplets on Chemically Heterogeneous Surfaces

    DEFF Research Database (Denmark)

    Larsen, Simon Tylsgaard; Taboryski, Rafael Jozef

    2009-01-01

    We present experimental contact angle data for surfaces, which were surface-engineered with a hydrophobic micropattern of hexagonal geometry. The chemically heterogeneous surface of the same hexagonal pattern of defects resulted in faceted droplets of hexagonal shape. When measuring the advancing...... contact angles with a viewing position aligned parallel to rows of defects, we found that an area averaged Cassie-law failed in describing the data. By replacing the area fractions by line fractions of the triple phase boundary Line segments in the Cassie equation, we found excellent agreement with data....

  19. Unified Alignment of Protein-Protein Interaction Networks.

    Science.gov (United States)

    Malod-Dognin, Noël; Ban, Kristina; Pržulj, Nataša

    2017-04-19

    Paralleling the increasing availability of protein-protein interaction (PPI) network data, several network alignment methods have been proposed. Network alignments have been used to uncover functionally conserved network parts and to transfer annotations. However, due to the computational intractability of the network alignment problem, aligners are heuristics providing divergent solutions and no consensus exists on a gold standard, or which scoring scheme should be used to evaluate them. We comprehensively evaluate the alignment scoring schemes and global network aligners on large scale PPI data and observe that three methods, HUBALIGN, L-GRAAL and NATALIE, regularly produce the most topologically and biologically coherent alignments. We study the collective behaviour of network aligners and observe that PPI networks are almost entirely aligned with a handful of aligners that we unify into a new tool, Ulign. Ulign enables complete alignment of two networks, which traditional global and local aligners fail to do. Also, multiple mappings of Ulign define biologically relevant soft clusterings of proteins in PPI networks, which may be used for refining the transfer of annotations across networks. Hence, PPI networks are already well investigated by current aligners, so to gain additional biological insights, a paradigm shift is needed. We propose such a shift come from aligning all available data types collectively rather than any particular data type in isolation from others.

  20. Simulation based assembly and alignment process ability analysis for line replaceable units of the high power solid state laser facility

    International Nuclear Information System (INIS)

    Wang, Junfeng; Lu, Cong; Li, Shiqi

    2016-01-01

    Highlights: • Discrete event simulation is applied to analyze the assembly and alignment process ability of LRUs in SG-III facility. • The overall assembly and alignment process of LRUs with specific characteristics is described. • An extended-directed graph is proposed to express the assembly and alignment process of LRUs. • Different scenarios have been simulated to evaluate assembling process ability of LRUs and decision making is supported to ensure the construction millstone. - Abstract: Line replaceable units (LRUs) are important components of the very large high power solid state laser facilities. The assembly and alignment process ability of LRUs will impact the construction milestone of facilities. This paper describes the use of discrete event simulation method for assembly and alignment process analysis of LRUs in such facilities. The overall assembly and alignment process for LRUs is presented based on the layout of the optics assembly laboratory and the process characteristics are analyzed. An extended-directed graph is proposed to express the assembly and alignment process of LRUs. Taking the LRUs of disk amplifier system in Shen Guang-III (SG-III) facility as the example, some process simulation models are built based on the Quest simulation platform. The constraints, such as duration, equipment, technician and part supply, are considered in the simulation models. Different simulation scenarios have been carried out to evaluate the assembling process ability of LRUs. The simulation method can provide a valuable decision making and process optimization tool for the optics assembly laboratory layout and the process working out of such facilities.

  1. Simulation based assembly and alignment process ability analysis for line replaceable units of the high power solid state laser facility

    Energy Technology Data Exchange (ETDEWEB)

    Wang, Junfeng; Lu, Cong; Li, Shiqi, E-mail: sqli@hust.edu.cn

    2016-11-15

    Highlights: • Discrete event simulation is applied to analyze the assembly and alignment process ability of LRUs in SG-III facility. • The overall assembly and alignment process of LRUs with specific characteristics is described. • An extended-directed graph is proposed to express the assembly and alignment process of LRUs. • Different scenarios have been simulated to evaluate assembling process ability of LRUs and decision making is supported to ensure the construction millstone. - Abstract: Line replaceable units (LRUs) are important components of the very large high power solid state laser facilities. The assembly and alignment process ability of LRUs will impact the construction milestone of facilities. This paper describes the use of discrete event simulation method for assembly and alignment process analysis of LRUs in such facilities. The overall assembly and alignment process for LRUs is presented based on the layout of the optics assembly laboratory and the process characteristics are analyzed. An extended-directed graph is proposed to express the assembly and alignment process of LRUs. Taking the LRUs of disk amplifier system in Shen Guang-III (SG-III) facility as the example, some process simulation models are built based on the Quest simulation platform. The constraints, such as duration, equipment, technician and part supply, are considered in the simulation models. Different simulation scenarios have been carried out to evaluate the assembling process ability of LRUs. The simulation method can provide a valuable decision making and process optimization tool for the optics assembly laboratory layout and the process working out of such facilities.

  2. Operating system design of parallel computer for on-line management of nuclear pressurised water reactor cores

    International Nuclear Information System (INIS)

    Gougam, F.

    1991-04-01

    This study is part of the PHAETON project which aims at increasing the knowledge of safety parameters of PWR core and reducing operating margins during the reactor cycle. The on-line system associates a simulator process to compute the three dimensional flux distribution and an acquisition process of reactor core parameters from the central instrumentation. The 3D flux calculation is the most time consuming. So, for cost and safety reasons, the PHAETON project proposes an approach which is to parallelize the 3D diffusion calculation and to use a computer based on parallel processor architecture. This paper presents the design of the operating system on which the application is executed. The routine interface proposed, includes the main operations necessary for programming a real time and parallel application. The primitives include: task management, data transfer, synchronisation by event signalling and by using the rendez-vous mechanisms. The primitives which are proposed use standard softwares like real-time kernel and UNIX operating system [fr

  3. Design of a chemical batch plant : a study of dedicated parallel lines with intermediate storage and the plant performance

    OpenAIRE

    Verbiest, Floor; Cornelissens, Trijntje; Springael, Johan

    2016-01-01

    Abstract: Production plants worldwide face huge challenges in satisfying high service levels and outperforming competition. These challenges require appropriate strategic decisions on plant design and production strategies. In this paper, we focus on multiproduct chemical batch plants, which are typically equipped with multiple production lines and intermediate storage tanks. First we extend the existing MI(N) LP design models with the concept of parallel production lines, and optimise the as...

  4. Shear Alignment of Diblock Copolymers for Patterning Nanowire Meshes

    Energy Technology Data Exchange (ETDEWEB)

    Gustafson, Kyle T. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2016-09-08

    Metallic nanowire meshes are useful as cheap, flexible alternatives to indium tin oxide – an expensive, brittle material used in transparent conductive electrodes. We have fabricated nanowire meshes over areas up to 2.5 cm2 by: 1) mechanically aligning parallel rows of diblock copolymer (diBCP) microdomains; 2) selectively infiltrating those domains with metallic ions; 3) etching away the diBCP template; 4) sintering to reduce ions to metal nanowires; and, 5) repeating steps 1 – 4 on the same sample at a 90° offset. We aligned parallel rows of polystyrene-b-poly(2-vinylpyridine) [PS(48.5 kDa)-b-P2VP(14.5 kDa)] microdomains by heating above its glass transition temperature (Tg ≈ 100°C), applying mechanical shear pressure (33 kPa) and normal force (13.7 N), and cooling below Tg. DiBCP samples were submerged in aqueous solutions of metallic ions (15 – 40 mM ions; 0.1 – 0.5 M HCl) for 30 – 90 minutes, which coordinate to nitrogen in P2VP. Subsequent ozone-etching and sintering steps yielded parallel nanowires. We aimed to optimize alignment parameters (e.g. shear and normal pressures, alignment duration, and PDMS thickness) to improve the quality, reproducibility, and scalability of meshes. We also investigated metals other than Pt and Au that may be patterned using this technique (Cu, Ag).

  5. Mechanism of parallel electric fields inferred from observations

    International Nuclear Information System (INIS)

    Yeh, H.; Hill, T.W.

    1981-01-01

    An analysis of satellite data from regions of upward Birkeland (magnetic-field-aligned) current shows that the typical magnetic-field-aligned potential drop in the auroral zone is larger than required to provide direct acceleration of magnetospheric electrons by the field-aligned electric field against the upward magnetic force to produce the observed upward Birkeland current. A model of simple electrostatic acceleration without anomalous resistivity predicts observable relations between parallel current and parallel potential drop and between energy deposition and parallel potential drop. The temperature, density, and species of the unaccelerated charge carriers are the relevant parameters of the model. Simultaneously measurements of electron precipitation and ion drift velocities on the satellites Atmosphere Explorere C and D were used to test these relations. In a steady state the divergence of ionospheric currents must be compensated by Birkeland currents. The model current-voltage relation was applied to predict the densities of the primary charge carriers (i.e., plasma sheet electrons above the acceleration region for upward currents). In cases involving thin arc structures, where the reliable estimation of the divergence of ionospheric current is difficult and the steady-state assumption may not apply, the precipitating energy flux versus voltage relation was used to predict the densities of the unaccelerated plasma sheet electrons. Within the experimental uncertainties, reasonable agreement is found between these predicted densities and those inferred directly from the simultaneous data of the Low-Energy Electron Experiment. These results are interpreted as indicating that anomalous resistivity is not important in determining the magnitude of the field-aligned potential drop in the auroral zone

  6. Attempt to identify the functional areas of the cerebral cortex on CT slices parallel to the orbito-meatal line

    Energy Technology Data Exchange (ETDEWEB)

    Tanabe, Hirotaka; Okuda, Junichiro; Nishikawa, Takashi; Nishimura, Tsuyoshi (Osaka Univ. (Japan). Faculty of Medicine); Shiraishi, Junzo

    1982-06-01

    In order to identify the functional brain areas, such as Broca's area, on computed tomography slices parallel to the orbito-meatal line, the numbers of Brodmann's cortical mapping were shown on a diagram of representative brain sections parallel to the orbito-meatal line. Also, we described a method, using cerebral sulci as anatomical landmarks, for projecting lesions shown by CT scan onto the lateral brain diagram. The procedures were as follows. The distribution of lesions on CT slices was determined by the identification of major cerebral sulci and fissures, such as the Sylvian fissure, the central sulcus, and the superior frontal sulcus. Those lesions were then projected onto the lateral diagram by comparing each CT slice with the horizontal diagrams of brain sections. The method was demonstrated in three cases developing neuropsychological symptoms.

  7. Enhanced pyroelectric and piezoelectric properties of PZT with aligned porosity for energy harvesting applications.

    Science.gov (United States)

    Zhang, Yan; Xie, Mengying; Roscow, James; Bao, Yinxiang; Zhou, Kechao; Zhang, Dou; Bowen, Chris R

    2017-04-14

    This paper demonstrates the significant benefits of exploiting highly aligned porosity in piezoelectric and pyroelectric materials for improved energy harvesting performance. Porous lead zirconate (PZT) ceramics with aligned pore channels and varying fractions of porosity were manufactured in a water-based suspension using freeze-casting. The aligned porous PZT ceramics were characterized in detail for both piezoelectric and pyroelectric properties and their energy harvesting performance figures of merit were assessed parallel and perpendicular to the freezing direction. As a result of the introduction of porosity into the ceramic microstructure, high piezoelectric and pyroelectric harvesting figures of merits were achieved for porous freeze-cast PZT compared to dense PZT due to the reduced permittivity and volume specific heat capacity. Experimental results were compared to parallel and series analytical models with good agreement and the PZT with porosity aligned parallel to the freezing direction exhibited the highest piezoelectric and pyroelectric harvesting response; this was a result of the enhanced interconnectivity of the ferroelectric material along the poling direction and reduced fraction of unpoled material that leads to a higher polarization. A complete thermal energy harvesting system, composed of a parallel-aligned PZT harvester element and an AC/DC converter, was successfully demonstrated by charging a storage capacitor. The maximum energy density generated by the 60 vol% porous parallel-connected PZT when subjected to thermal oscillations was 1653 μJ cm -3 , which was 374% higher than that of the dense PZT with an energy density of 446 μJ cm -3 . The results are beneficial for the design and manufacture of high performance porous pyroelectric and piezoelectric materials in devices for energy harvesting and sensor applications.

  8. An attempt to identify the functional areas of the cerebral cortex on CT slices parallel to the orbito-meatal line

    International Nuclear Information System (INIS)

    Tanabe, Hirotaka; Okuda, Junichiro; Nishikawa, Takashi; Nishimura, Tsuyoshi; Shiraishi, Junzo.

    1982-01-01

    In order to identify the functional brain areas, such as Broca's area, on computed tomography slices parallel to the orbito-meatal line, the numbers of Brodmann's cortical mapping were shown on a diagram of representative brain sections parallel to the orbito-meatal line. Also, we described a method, using cerebral sulci as anatomical landmarks, for projecting lesions shown by CT scan onto the lateral brain diagram. The procedures were as follows. The distribution of lesions on CT slices was determined by the identification of major cerebral sulci and fissures, such as the Sylvian fissure, the central sulcus, and the superior frontal sulcus. Those lesions were then projected onto the lateral diagram by comparing each CT slice with the horizontal diagrams of brain sections. The method was demonstrated in three cases developing neuropsychological symptoms. (author)

  9. Automatic target alignment of the Helios laser system

    International Nuclear Information System (INIS)

    Liberman, I.; Viswanathan, V.K.; Klein, M.; Seery, B.D.

    1980-01-01

    An automatic target-alignment technique for the Helios laser facility is reported and verified experimentally. The desired alignment condition is completely described by an autocollimation test. A computer program examines the autocollimated return pattern from the surrogate target and correctly describes any changes required in mirror orientation to yield optimum targe alignment with either aberrated or misaligned beams. Automated on-line target alignment is thus shown to be feasible

  10. Flexible, fast and accurate sequence alignment profiling on GPGPU with PaSWAS.

    Directory of Open Access Journals (Sweden)

    Sven Warris

    Full Text Available To obtain large-scale sequence alignments in a fast and flexible way is an important step in the analyses of next generation sequencing data. Applications based on the Smith-Waterman (SW algorithm are often either not fast enough, limited to dedicated tasks or not sufficiently accurate due to statistical issues. Current SW implementations that run on graphics hardware do not report the alignment details necessary for further analysis.With the Parallel SW Alignment Software (PaSWAS it is possible (a to have easy access to the computational power of NVIDIA-based general purpose graphics processing units (GPGPUs to perform high-speed sequence alignments, and (b retrieve relevant information such as score, number of gaps and mismatches. The software reports multiple hits per alignment. The added value of the new SW implementation is demonstrated with two test cases: (1 tag recovery in next generation sequence data and (2 isotype assignment within an immunoglobulin 454 sequence data set. Both cases show the usability and versatility of the new parallel Smith-Waterman implementation.

  11. Flexible, fast and accurate sequence alignment profiling on GPGPU with PaSWAS.

    Science.gov (United States)

    Warris, Sven; Yalcin, Feyruz; Jackson, Katherine J L; Nap, Jan Peter

    2015-01-01

    To obtain large-scale sequence alignments in a fast and flexible way is an important step in the analyses of next generation sequencing data. Applications based on the Smith-Waterman (SW) algorithm are often either not fast enough, limited to dedicated tasks or not sufficiently accurate due to statistical issues. Current SW implementations that run on graphics hardware do not report the alignment details necessary for further analysis. With the Parallel SW Alignment Software (PaSWAS) it is possible (a) to have easy access to the computational power of NVIDIA-based general purpose graphics processing units (GPGPUs) to perform high-speed sequence alignments, and (b) retrieve relevant information such as score, number of gaps and mismatches. The software reports multiple hits per alignment. The added value of the new SW implementation is demonstrated with two test cases: (1) tag recovery in next generation sequence data and (2) isotype assignment within an immunoglobulin 454 sequence data set. Both cases show the usability and versatility of the new parallel Smith-Waterman implementation.

  12. 600 GHz resonant mode in a parallel array of Josephson tunnel junctions connected by superconducting microstrip lines

    DEFF Research Database (Denmark)

    Kaplunenko, V. K.; Larsen, Britt Hvolbæk; Mygind, Jesper

    1994-01-01

    on experimental and numerical investigations of a resonant step observed at a voltage corresponding to 600 GHz in the dc current-voltage characteristic of a parallel array of 20 identical small NbAl2O3Nb Josephson junctions interconnected by short sections of superconducting microstrip line. The junctions...... are mutually phase locked due to collective interaction with the line sections excited close to the half wavelength resonance. The phase locking range can be adjusted by means of an external dc magnetic field and the step size varies periodically with the magnetic field. The largest step corresponds...

  13. Veel kord regilaulu parallelismist, poeetilisest sünonüümiast ja analoogiast/ Once more on the parallelism of runosong, on the poetical synonymy and analogy

    Directory of Open Access Journals (Sweden)

    Mari Sarv

    2016-01-01

    Relying on her own previous research on runosongs and proverbs demonstrating the mutual dependency of alliteration and parallelism typical to runosong (Sarv 1999, 2000, 2003, the results of syntactic analysis of runosong texts in H. Metslang’s dissertation (1978, Juhan Peegel’s definition of poetical synonyms in runosong (Peegel 2004, and Ewald Lang’s concept of quasisynonymy (Lang 1987, the author proposes the definition of the canonical parallelism of runosong as follows: it is a grammatical verse parallelism where all or some of the syntactic elements of the main verse have corresponding parallels in the successive lines representing the same general notion, and interpreted in the context of the parallelism as semantically equivalent, irrespective of their semantic relations in the colloquial language (equivalence, synonymy, metonymy, metaphor, analogy, antonymy, hyponymy etc.. Because of this semantical equivalence, the parallel words can be selected and combined into the parallel verses according to their formal features enabling the metrical alignment and alliteration. The article also points to the problems with the classification of runosong parallelism to the analogous and synonymous by Wolfgang Steinitz (1934, widely used in the runosong discourse: although analogy and synonymy probably represent the most remarkable semantic relations between the parallel lines, it is not easy to make clear distinction between synonymous and analogous lines (or concepts—even in the colloquial non-poetic language the synonyms are usually not equivalent in all aspects of meaning; the regular use of poetical synonyms in runosongs makes it impossible at all—the geese, ducks, and grouses as different birds are analogous in the colloquial language, but synonymous in the runosong all denoting the group of maidens.

  14. CloudAligner: A fast and full-featured MapReduce based tool for sequence mapping

    Directory of Open Access Journals (Sweden)

    Shi Weisong

    2011-06-01

    Full Text Available Abstract Background Research in genetics has developed rapidly recently due to the aid of next generation sequencing (NGS. However, massively-parallel NGS produces enormous amounts of data, which leads to storage, compatibility, scalability, and performance issues. The Cloud Computing and MapReduce framework, which utilizes hundreds or thousands of shared computers to map sequencing reads quickly and efficiently to reference genome sequences, appears to be a very promising solution for these issues. Consequently, it has been adopted by many organizations recently, and the initial results are very promising. However, since these are only initial steps toward this trend, the developed software does not provide adequate primary functions like bisulfite, pair-end mapping, etc., in on-site software such as RMAP or BS Seeker. In addition, existing MapReduce-based applications were not designed to process the long reads produced by the most recent second-generation and third-generation NGS instruments and, therefore, are inefficient. Last, it is difficult for a majority of biologists untrained in programming skills to use these tools because most were developed on Linux with a command line interface. Results To urge the trend of using Cloud technologies in genomics and prepare for advances in second- and third-generation DNA sequencing, we have built a Hadoop MapReduce-based application, CloudAligner, which achieves higher performance, covers most primary features, is more accurate, and has a user-friendly interface. It was also designed to be able to deal with long sequences. The performance gain of CloudAligner over Cloud-based counterparts (35 to 80% mainly comes from the omission of the reduce phase. In comparison to local-based approaches, the performance gain of CloudAligner is from the partition and parallel processing of the huge reference genome as well as the reads. The source code of CloudAligner is available at http

  15. CloudAligner: A fast and full-featured MapReduce based tool for sequence mapping.

    Science.gov (United States)

    Nguyen, Tung; Shi, Weisong; Ruden, Douglas

    2011-06-06

    Research in genetics has developed rapidly recently due to the aid of next generation sequencing (NGS). However, massively-parallel NGS produces enormous amounts of data, which leads to storage, compatibility, scalability, and performance issues. The Cloud Computing and MapReduce framework, which utilizes hundreds or thousands of shared computers to map sequencing reads quickly and efficiently to reference genome sequences, appears to be a very promising solution for these issues. Consequently, it has been adopted by many organizations recently, and the initial results are very promising. However, since these are only initial steps toward this trend, the developed software does not provide adequate primary functions like bisulfite, pair-end mapping, etc., in on-site software such as RMAP or BS Seeker. In addition, existing MapReduce-based applications were not designed to process the long reads produced by the most recent second-generation and third-generation NGS instruments and, therefore, are inefficient. Last, it is difficult for a majority of biologists untrained in programming skills to use these tools because most were developed on Linux with a command line interface. To urge the trend of using Cloud technologies in genomics and prepare for advances in second- and third-generation DNA sequencing, we have built a Hadoop MapReduce-based application, CloudAligner, which achieves higher performance, covers most primary features, is more accurate, and has a user-friendly interface. It was also designed to be able to deal with long sequences. The performance gain of CloudAligner over Cloud-based counterparts (35 to 80%) mainly comes from the omission of the reduce phase. In comparison to local-based approaches, the performance gain of CloudAligner is from the partition and parallel processing of the huge reference genome as well as the reads. The source code of CloudAligner is available at http://cloudaligner.sourceforge.net/ and its web version is at http

  16. Alignment between Protostellar Outflows and Filamentary Structure

    Energy Technology Data Exchange (ETDEWEB)

    Stephens, Ian W.; Dunham, Michael M.; Myers, Philip C.; Pokhrel, Riwaj; Sadavoy, Sarah I.; Lee, Katherine I.; Goodman, Alyssa A. [Harvard-Smithsonian Center for Astrophysics, 60 Garden Street, Cambridge, MA (United States); Vorobyov, Eduard I. [Institute of Fluid Mechanics and Heat Transfer, TU Wien, Vienna, A-1060 (Austria); Tobin, John J. [Homer L. Dodge Department of Physics and Astronomy, University of Oklahoma, 440 W. Brooks Street, Norman, OK 73019 (United States); Pineda, Jaime E. [Max-Planck-Institut für extraterrestrische Physik, Giessenbachstrasse 1, 85748 Garching (Germany); Offner, Stella S. R. [Department of Astronomy, University of Massachusetts, Amherst, MA 01003 (United States); Kristensen, Lars E. [Centre for Star and Planet Formation, Niels Bohr Institute and Natural History Museum of Denmark, University of Copenhagen, Øster Voldgade 5-7, DK-1350 Copenhagen K (Denmark); Jørgensen, Jes K. [Niels Bohr Institute and Center for Star and Planet Formation, Copenhagen University, DK-1350 Copenhagen K. (Denmark); Bourke, Tyler L. [SKA Organization, Jodrell Bank Observatory, Lower Withington, Macclesfield, Cheshire SK11 9DL (United Kingdom); Arce, Héctor G. [Department of Astronomy, Yale University, New Haven, CT 06520 (United States); Plunkett, Adele L., E-mail: ian.stephens@cfa.harvard.edu [European Southern Observatory, Av. Alonso de Cordova 3107, Vitacura, Santiago de Chile (Chile)

    2017-09-01

    We present new Submillimeter Array (SMA) observations of CO(2–1) outflows toward young, embedded protostars in the Perseus molecular cloud as part of the Mass Assembly of Stellar Systems and their Evolution with the SMA (MASSES) survey. For 57 Perseus protostars, we characterize the orientation of the outflow angles and compare them with the orientation of the local filaments as derived from Herschel observations. We find that the relative angles between outflows and filaments are inconsistent with purely parallel or purely perpendicular distributions. Instead, the observed distribution of outflow-filament angles are more consistent with either randomly aligned angles or a mix of projected parallel and perpendicular angles. A mix of parallel and perpendicular angles requires perpendicular alignment to be more common by a factor of ∼3. Our results show that the observed distributions probably hold regardless of the protostar’s multiplicity, age, or the host core’s opacity. These observations indicate that the angular momentum axis of a protostar may be independent of the large-scale structure. We discuss the significance of independent protostellar rotation axes in the general picture of filament-based star formation.

  17. BFAST: an alignment tool for large scale genome resequencing.

    Directory of Open Access Journals (Sweden)

    Nils Homer

    2009-11-01

    Full Text Available The new generation of massively parallel DNA sequencers, combined with the challenge of whole human genome resequencing, result in the need for rapid and accurate alignment of billions of short DNA sequence reads to a large reference genome. Speed is obviously of great importance, but equally important is maintaining alignment accuracy of short reads, in the 25-100 base range, in the presence of errors and true biological variation.We introduce a new algorithm specifically optimized for this task, as well as a freely available implementation, BFAST, which can align data produced by any of current sequencing platforms, allows for user-customizable levels of speed and accuracy, supports paired end data, and provides for efficient parallel and multi-threaded computation on a computer cluster. The new method is based on creating flexible, efficient whole genome indexes to rapidly map reads to candidate alignment locations, with arbitrary multiple independent indexes allowed to achieve robustness against read errors and sequence variants. The final local alignment uses a Smith-Waterman method, with gaps to support the detection of small indels.We compare BFAST to a selection of large-scale alignment tools -- BLAT, MAQ, SHRiMP, and SOAP -- in terms of both speed and accuracy, using simulated and real-world datasets. We show BFAST can achieve substantially greater sensitivity of alignment in the context of errors and true variants, especially insertions and deletions, and minimize false mappings, while maintaining adequate speed compared to other current methods. We show BFAST can align the amount of data needed to fully resequence a human genome, one billion reads, with high sensitivity and accuracy, on a modest computer cluster in less than 24 hours. BFAST is available at (http://bfast.sourceforge.net.

  18. DNAAlignEditor: DNA alignment editor tool

    Directory of Open Access Journals (Sweden)

    Guill Katherine E

    2008-03-01

    Full Text Available Abstract Background With advances in DNA re-sequencing methods and Next-Generation parallel sequencing approaches, there has been a large increase in genomic efforts to define and analyze the sequence variability present among individuals within a species. For very polymorphic species such as maize, this has lead to a need for intuitive, user-friendly software that aids the biologist, often with naïve programming capability, in tracking, editing, displaying, and exporting multiple individual sequence alignments. To fill this need we have developed a novel DNA alignment editor. Results We have generated a nucleotide sequence alignment editor (DNAAlignEditor that provides an intuitive, user-friendly interface for manual editing of multiple sequence alignments with functions for input, editing, and output of sequence alignments. The color-coding of nucleotide identity and the display of associated quality score aids in the manual alignment editing process. DNAAlignEditor works as a client/server tool having two main components: a relational database that collects the processed alignments and a user interface connected to database through universal data access connectivity drivers. DNAAlignEditor can be used either as a stand-alone application or as a network application with multiple users concurrently connected. Conclusion We anticipate that this software will be of general interest to biologists and population genetics in editing DNA sequence alignments and analyzing natural sequence variation regardless of species, and will be particularly useful for manual alignment editing of sequences in species with high levels of polymorphism.

  19. Three dimensional extrusion printing induces polymer molecule alignment and cell organization within engineered cartilage.

    Science.gov (United States)

    Guo, Ting; Ringel, Julia P; Lim, Casey G; Bracaglia, Laura G; Noshin, Maeesha; Baker, Hannah B; Powell, Douglas A; Fisher, John P

    2018-04-16

    Proper cell-material interactions are critical to remain cell function and thus successful tissue regeneration. Many fabrication processes have been developed to create microenvironments to control cell attachment and organization on a three-dimensional (3D) scaffold. However, these approaches often involve heavy engineering and only the surface layer can be patterned. We found that 3D extrusion based printing at high temperature and pressure will result an aligned effect on the polymer molecules, and this molecular arrangement will further induce the cell alignment and different differentiation capacities. In particular, articular cartilage tissue is known to have zonal collagen fiber and cell orientation to support different functions, where collagen fibers and chondrocytes align parallel, randomly, and perpendicular, respectively, to the surface of the joint. Therefore, cell alignment was evaluated in a cartilage model in this study. We used small angle X-ray scattering analysis to substantiate the polymer molecule alignment phenomenon. The cellular response was evaluated both in vitro and in vivo. Seeded mesenchymal stem cells (MSCs) showed different morphology and orientation on scaffolds, as a combined result of polymer molecule alignment and printed scaffold patterns. Gene expression results showed improved superficial zonal chondrogenic marker expression in parallel-aligned group. The cell alignment was successfully maintained in the animal model after 7 days with distinct MSC morphology between the casted and parallel printed scaffolds. This 3D printing induced polymer and cell alignment will have a significant impact on developing scaffold with controlled cell-material interactions for complex tissue engineering while avoiding complicated surface treatment, and therefore provides new concept for effective tissue repairing in future clinical applications. © 2018 Wiley Periodicals, Inc. J Biomed Mater Res Part A, 2018. © 2018 Wiley Periodicals, Inc.

  20. Alignment of Partnering with Construction IT

    Directory of Open Access Journals (Sweden)

    Eleni Papadonikolaki

    2017-11-01

     As the construction industry evolves into an information-driven sector, the alignment of construction IT with inter-organisational management is preeminent for managing the inherent complexities of the industry. In parallel, embracing inter-organisational approaches for information management such as BIM is a promisingway forward for SCM and construction management.

  1. Magnetosphere-ionosphere coupling currents in Jupiter's middle magnetosphere: effect of magnetosphere-ionosphere decoupling by field-aligned auroral voltages

    Directory of Open Access Journals (Sweden)

    J. D. Nichols

    2005-03-01

    Full Text Available We consider the effect of field-aligned voltages on the magnetosphere-ionosphere coupling current system associated with the breakdown of rigid corotation of equatorial plasma in Jupiter's middle magnetosphere. Previous analyses have assumed perfect mapping of the electric field and flow along equipotential field lines between the equatorial plane and the ionosphere, whereas it has been shown that substantial field-aligned voltages must exist to drive the field-aligned currents associated with the main auroral oval. The effect of these field-aligned voltages is to decouple the flow of the equatorial and ionospheric plasma, such that their angular velocities are in general different from each other. In this paper we self-consistently include the field-aligned voltages in computing the plasma flows and currents in the system. A third order differential equation is derived for the ionospheric plasma angular velocity, and a power series solution obtained which reduces to previous solutions in the limit that the field-aligned voltage is small. Results are obtained to second order in the power series, and are compared to the original zeroth order results with no parallel voltage. We find that for system parameters appropriate to Jupiter the effect of the field-aligned voltages on the solutions is small, thus validating the results of previously-published analyses.

  2. Alignment enhancement of a symmetric top molecule by two short laser pulses

    DEFF Research Database (Denmark)

    Bisgaard, Christer Z; Viftrup, Simon; Stapelfeldt, Henrik

    2006-01-01

    equation. It is shown that the strongest degree of one-dimensional (single axis) field-free alignment obtainable with a single pulse can be enhanced using the two-pulse sequence in a parallel polarization geometry. The conditions for alignment enhancement are: (1) The second pulse must be sent near...

  3. Advanced mathematical on-line analysis in nuclear experiments. Usage of parallel computing CUDA routines in standard root analysis

    Science.gov (United States)

    Grzeszczuk, A.; Kowalski, S.

    2015-04-01

    Compute Unified Device Architecture (CUDA) is a parallel computing platform developed by Nvidia for increase speed of graphics by usage of parallel mode for processes calculation. The success of this solution has opened technology General-Purpose Graphic Processor Units (GPGPUs) for applications not coupled with graphics. The GPGPUs system can be applying as effective tool for reducing huge number of data for pulse shape analysis measures, by on-line recalculation or by very quick system of compression. The simplified structure of CUDA system and model of programming based on example Nvidia GForce GTX580 card are presented by our poster contribution in stand-alone version and as ROOT application.

  4. Fixture for aligning motor assembly

    Science.gov (United States)

    Shervington, Roger M.; Vaghani, Vallabh V.; Vanek, Laurence D.; Christensen, Scott A.

    2009-12-08

    An alignment fixture includes a rotor fixture, a stator fixture and a sensor system which measures a rotational displacement therebetween. The fixture precisely measures rotation of a generator stator assembly away from a NULL position referenced by a unique reference spline on the rotor shaft. By providing an adjustable location of the stator assembly within the housing, the magnetic axes within each generator shall be aligned to a predetermined and controlled tolerance between the generator interface mounting pin and the reference spline on the rotor shaft. Once magnetically aligned, each generator is essentially a line replaceable unit which may be readily mounted to any input of a multi-generator gearbox assembly with the assurance that the magnetic alignment will be within a predetermined tolerance.

  5. A general assignment method for oriented sample (OS) solid-state NMR of proteins based on the correlation of resonances through heteronuclear dipolar couplings in samples aligned parallel and perpendicular to the magnetic field.

    Science.gov (United States)

    Lu, George J; Son, Woo Sung; Opella, Stanley J

    2011-04-01

    A general method for assigning oriented sample (OS) solid-state NMR spectra of proteins is demonstrated. In principle, this method requires only a single sample of a uniformly ¹⁵N-labeled membrane protein in magnetically aligned bilayers, and a previously assigned isotropic chemical shift spectrum obtained either from solution NMR on micelle or isotropic bicelle samples or from magic angle spinning (MAS) solid-state NMR on unoriented proteoliposomes. The sequential isotropic resonance assignments are transferred to the OS solid-state NMR spectra of aligned samples by correlating signals from the same residue observed in protein-containing bilayers aligned with their normals parallel and perpendicular to the magnetic field. The underlying principle is that the resonances from the same residue have heteronuclear dipolar couplings that differ by exactly a factor of two between parallel and perpendicular alignments. The method is demonstrated on the membrane-bound form of Pf1 coat protein in phospholipid bilayers, whose assignments have been previously made using an earlier generation of methods that relied on the preparation of many selectively labeled (by residue type) samples. The new method provides the correct resonance assignments using only a single uniformly ¹⁵N-labeled sample, two solid-state NMR spectra, and a previously assigned isotropic spectrum. Significantly, this approach is equally applicable to residues in alpha helices, beta sheets, loops, and any other elements of tertiary structure. Moreover, the strategy bridges between OS solid-state NMR of aligned samples and solution NMR or MAS solid-state NMR of unoriented samples. In combination with the development of complementary experimental methods, it provides a step towards unifying these apparently different NMR approaches. Copyright © 2011 Elsevier Inc. All rights reserved.

  6. GRILLIX. A 3D turbulence code for magnetic fusion devices based on a field line map

    International Nuclear Information System (INIS)

    Stegmeir, Andreas Korbinian

    2015-01-01

    The complex geometry in the scrape-off layer of tokamaks poses problems to existing turbulence codes. The usually employed field aligned coordinates become ill defined at the separatrix. Therefore the parallel code GRILLIX was developed, which is based on a field line map. This allows simulations in additional complex geometries, especially across the separatrix. A new discretisation, based on the support operator method, for the highly anisotropic diffusion was developed and applied to a simple turbulence model (Hasegawa-Wakatani).

  7. Compiler Technology for Parallel Scientific Computation

    Directory of Open Access Journals (Sweden)

    Can Özturan

    1994-01-01

    Full Text Available There is a need for compiler technology that, given the source program, will generate efficient parallel codes for different architectures with minimal user involvement. Parallel computation is becoming indispensable in solving large-scale problems in science and engineering. Yet, the use of parallel computation is limited by the high costs of developing the needed software. To overcome this difficulty we advocate a comprehensive approach to the development of scalable architecture-independent software for scientific computation based on our experience with equational programming language (EPL. Our approach is based on a program decomposition, parallel code synthesis, and run-time support for parallel scientific computation. The program decomposition is guided by the source program annotations provided by the user. The synthesis of parallel code is based on configurations that describe the overall computation as a set of interacting components. Run-time support is provided by the compiler-generated code that redistributes computation and data during object program execution. The generated parallel code is optimized using techniques of data alignment, operator placement, wavefront determination, and memory optimization. In this article we discuss annotations, configurations, parallel code generation, and run-time support suitable for parallel programs written in the functional parallel programming language EPL and in Fortran.

  8. Evolution of shiva laser alignment systems

    International Nuclear Information System (INIS)

    Boyd, R.D.

    1980-07-01

    The Shiva oscillator pulse is preamplified and divided into twenty beams. Each beam is then amplified, spatially filtered, directed, and focused onto a target a few hundred micrometers in size producing optical intensities up to 10 16 W/cm 2 . The laser was designed and built with three automatic alignment systems: the oscillator alignment system, which aligns each of the laser's three oscillators to a reference beamline; the chain input pointing system, which points each beam into its respective chain; and the chain output pointing, focusing and centering system which points, centers and focuses the beam onto the target. Recently the alignment of the laser's one hundred twenty spatial filter pinholes was also automated. This system uses digitized video images of back-illuminated pinholes and computer analysis to determine current positions. The offset of each current position from a desired center point is then translated into stepper motor commands and the pinhole is moved the proper distance. While motors for one pinhole are moving, the system can digitize, analyze, and send commands to other motors, allowing the system to efficiently align several pinholes in parallel

  9. MOEA based design of decentralized controllers for LFC of interconnected power systems with nonlinearities, AC-DC parallel tie-lines and SMES units

    International Nuclear Information System (INIS)

    Ganapathy, S.; Velusami, S.

    2010-01-01

    A new design of Multi-Objective Evolutionary Algorithm based decentralized controllers for load-frequency control of interconnected power systems with Governor Dead Band and Generation Rate Constraint nonlinearities, AC-DC parallel tie-lines and Superconducting Magnetic Energy Storage (SMES) units, is proposed in this paper. The HVDC link is used as system interconnection in parallel with AC tie-line to effectively damp the frequency oscillations of AC system while the SMES unit provides bulk energy storage and release, thereby achieving combined benefits. The proposed controller satisfies two main objectives, namely, minimum Integral Squared Error of the system output and maximum closed-loop stability of the system. Simulation studies are conducted on a two area interconnected power system with nonlinearities, AC-DC tie-lines and SMES units. Results indicate that the proposed controller improves the transient responses and guarantees the closed-loop stability of the overall system even in the presence of system nonlinearities and with parameter changes.

  10. Antares automatic beam alignment system

    International Nuclear Information System (INIS)

    Appert, Q.; Swann, T.; Sweatt, W.; Saxman, A.

    1980-01-01

    Antares is a 24-beam-line CO 2 laser system for controlled fusion research, under construction at Los Alamos Scientific Laboratory (LASL). Rapid automatic alignment of this system is required prior to each experiment shot. The alignment requirements, operational constraints, and a developed prototype system are discussed. A visible-wavelength alignment technique is employed that uses a telescope/TV system to view point light sources appropriately located down the beamline. Auto-alignment is accomplished by means of a video centroid tracker, which determines the off-axis error of the point sources. The error is nulled by computer-driven, movable mirrors in a closed-loop system. The light sources are fiber-optic terminations located at key points in the optics path, primarily at the center of large copper mirrors, and remotely illuminated to reduce heating effects

  11. Advanced mathematical on-line analysis in nuclear experiments. Usage of parallel computing CUDA routines in standard root analysis

    Directory of Open Access Journals (Sweden)

    Grzeszczuk A.

    2015-01-01

    Full Text Available Compute Unified Device Architecture (CUDA is a parallel computing platform developed by Nvidia for increase speed of graphics by usage of parallel mode for processes calculation. The success of this solution has opened technology General-Purpose Graphic Processor Units (GPGPUs for applications not coupled with graphics. The GPGPUs system can be applying as effective tool for reducing huge number of data for pulse shape analysis measures, by on-line recalculation or by very quick system of compression. The simplified structure of CUDA system and model of programming based on example Nvidia GForce GTX580 card are presented by our poster contribution in stand-alone version and as ROOT application.

  12. LHCb: Experience with LHCb alignment software on first data

    CERN Multimedia

    Deissenroth, M

    2009-01-01

    We report results obtained with different track-based algorithms for the alignment of the LHCb detector with first data. The large-area Muon Detector and Outer Tracker have been aligned with a large sample of tracks from cosmic rays. The three silicon detectors --- VELO, TT-station and Inner Tracker --- have been aligned with beam-induced events from the LHC injection line. We compare the results from the track-based alignment with expectations from detector survey.

  13. Software alignment of the LHCb inner tracker sensors

    Energy Technology Data Exchange (ETDEWEB)

    Maciuc, Florin

    2009-04-20

    This work uses the Millepede linear alignment method, which is essentially a {chi}{sup 2} minimization algorithm, to determine simultaneously between 76 and 476 alignment parameters and several million track parameters. For the case of non-linear alignment models, Millepede is embedded in a Newton-Raphson iterative procedure. If needed a more robust approach is provided by adding quasi-Newton steps which minimize the approximate {chi}{sup 2} model function. The alignment apparatus is applied to locally align the LHCb's Inner Tracker sensors in an a priori fixed system of coordinate. An analytic measurement model was derived as function of track parameters and alignment parameters, for the two cases: null and nonnull magnetic field. The alignment problem is equivalent to solving a linear system of equations, and usually a matrix inversion is required. In general, as consequence of global degrees of freedom or poorly constrained modes, the alignment matrix is singular or near-singular. The global degrees of freedom are obtained: directly from {chi}{sup 2} function invariant transformations, and in parallel by an alignment matrix diagonalization followed by an extraction of the least constrained modes. The procedure allows to properly de ne the local alignment of the Inner Tracker. Using Monte Carlo data, the outlined procedure reconstructs the position of the IT sensors within micrometer precision or better. For rotations equivalent precision was obtained. (orig.)

  14. Software alignment of the LHCb inner tracker sensors

    International Nuclear Information System (INIS)

    Maciuc, Florin

    2009-01-01

    This work uses the Millepede linear alignment method, which is essentially a χ 2 minimization algorithm, to determine simultaneously between 76 and 476 alignment parameters and several million track parameters. For the case of non-linear alignment models, Millepede is embedded in a Newton-Raphson iterative procedure. If needed a more robust approach is provided by adding quasi-Newton steps which minimize the approximate χ 2 model function. The alignment apparatus is applied to locally align the LHCb's Inner Tracker sensors in an a priori fixed system of coordinate. An analytic measurement model was derived as function of track parameters and alignment parameters, for the two cases: null and nonnull magnetic field. The alignment problem is equivalent to solving a linear system of equations, and usually a matrix inversion is required. In general, as consequence of global degrees of freedom or poorly constrained modes, the alignment matrix is singular or near-singular. The global degrees of freedom are obtained: directly from χ 2 function invariant transformations, and in parallel by an alignment matrix diagonalization followed by an extraction of the least constrained modes. The procedure allows to properly de ne the local alignment of the Inner Tracker. Using Monte Carlo data, the outlined procedure reconstructs the position of the IT sensors within micrometer precision or better. For rotations equivalent precision was obtained. (orig.)

  15. Software alignment of the LHCb inner tracker sensors

    Energy Technology Data Exchange (ETDEWEB)

    Maciuc, Florin

    2009-04-20

    This work uses the Millepede linear alignment method, which is essentially a {chi}{sup 2} minimization algorithm, to determine simultaneously between 76 and 476 alignment parameters and several million track parameters. For the case of non-linear alignment models, Millepede is embedded in a Newton-Raphson iterative procedure. If needed a more robust approach is provided by adding quasi-Newton steps which minimize the approximate {chi}{sup 2} model function. The alignment apparatus is applied to locally align the LHCb's Inner Tracker sensors in an a priori fixed system of coordinate. An analytic measurement model was derived as function of track parameters and alignment parameters, for the two cases: null and nonnull magnetic field. The alignment problem is equivalent to solving a linear system of equations, and usually a matrix inversion is required. In general, as consequence of global degrees of freedom or poorly constrained modes, the alignment matrix is singular or near-singular. The global degrees of freedom are obtained: directly from {chi}{sup 2} function invariant transformations, and in parallel by an alignment matrix diagonalization followed by an extraction of the least constrained modes. The procedure allows to properly de ne the local alignment of the Inner Tracker. Using Monte Carlo data, the outlined procedure reconstructs the position of the IT sensors within micrometer precision or better. For rotations equivalent precision was obtained. (orig.)

  16. Alignment of Ion Accelerator for Surface Analysis using Theodolite and Laser Tracker

    Energy Technology Data Exchange (ETDEWEB)

    Ahn, Tae Sung; Seo, Dong Hyuk; Kim, Dae Il; Kim, Han Sung; Kwon, Hyeok Jung; Cho, Yong Sub [KAERI, Daejeon (Korea, Republic of)

    2016-05-15

    The method of ion accelerator alignment is used two ways which are a theodolite and laser tracker. For the alignment and maintenance of the proton linear accelerator, the laser tracker is typically used at KOMAC. While the device for alignment by using laser tracker is not installed in all ion accelerator components, it was used in parallel in two methods. In this paper, alignment methods are introduced and the result and comparison of each alignment method are presented. The ion accelerator for surface analysis has aligned using theodolite and laser tracker. The two ways for alignment have advantage as well as weakness. But alignment using laser tracker is stronger than using theodolite. Because it is based on alignment and position data and it is more detailed. Also since the beam distribution is smaller than accelerator component that is direction of beam progress, main component (ex. Magnet, Chamber, Pelletron tank, etc.) alignment using laser tracker is enough to align the ion accelerator.

  17. Electric fields and field-aligned current generation in the magnetosphere

    International Nuclear Information System (INIS)

    Alexeev, I.I.; Belenkaya, E.S.; Kalegaev, V.V.; Lyutov, Yu.G.

    1993-01-01

    The authors present a calculation of the electric potential, field-aligned currents, and plasma convection caused by the penetration of the solar wind electric field into the magnetosphere. Ohm's law and the continuity equation of ionospheric currents are used. It is shown that the large-scale convection system is reversed in the plasma sheet flanks. In this region the plasma flow is antisunward earthward of the neutral line and sunward tailward of it. The interplanetary magnetic field (IMF) B z dependences on the dimension of the magnetopause open-quotes windowsclose quotes which are intersected by open field lines, on the potential drop across the polar cap, and on the distance to the neutral line are determined. Because of the IMF effect and the effect of seasonal or daily variations of the geomagnetic field which violate its symmetry relative to the equatorial plane, there may arise a potential drop along field lines which causes field-aligned currents. The values and directions of these currents, the field-aligned potential drop, and a self-consistent solution for the potential at the ionosphere level for high field-aligned conductivity have been determined. 41 refs., 7 figs

  18. Getting Your Peaks in Line: A Review of Alignment Methods for NMR Spectral Data

    Directory of Open Access Journals (Sweden)

    Trung Nghia Vu

    2013-04-01

    Full Text Available One of the most significant challenges in the comparative analysis of Nuclear Magnetic Resonance (NMR metabolome profiles is the occurrence of shifts between peaks across different spectra, for example caused by fluctuations in pH, temperature, instrument factors and ion content. Proper alignment of spectral peaks is therefore often a crucial preprocessing step prior to downstream quantitative analysis. Various alignment methods have been developed specifically for this purpose. Other methods were originally developed to align other data types (GC, LC, SELDI-MS, etc., but can also be applied to NMR data. This review discusses the available methods, as well as related problems such as reference determination or the evaluation of alignment quality. We present a generic alignment framework that allows for comparison and classification of different alignment approaches according to their algorithmic principles, and we discuss their performance.

  19. Parallel mRNA, proteomics and miRNA expression analysis in cell line models of the intestine.

    Science.gov (United States)

    O'Sullivan, Finbarr; Keenan, Joanne; Aherne, Sinead; O'Neill, Fiona; Clarke, Colin; Henry, Michael; Meleady, Paula; Breen, Laura; Barron, Niall; Clynes, Martin; Horgan, Karina; Doolan, Padraig; Murphy, Richard

    2017-11-07

    To identify miRNA-regulated proteins differentially expressed between Caco2 and HT-29: two principal cell line models of the intestine. Exponentially growing Caco-2 and HT-29 cells were harvested and prepared for mRNA, miRNA and proteomic profiling. mRNA microarray profiling analysis was carried out using the Affymetrix GeneChip Human Gene 1.0 ST array. miRNA microarray profiling analysis was carried out using the Affymetrix Genechip miRNA 3.0 array. Quantitative Label-free LC-MS/MS proteomic analysis was performed using a Dionex Ultimate 3000 RSLCnano system coupled to a hybrid linear ion trap/Orbitrap mass spectrometer. Peptide identities were validated in Proteome Discoverer 2.1 and were subsequently imported into Progenesis QI software for further analysis. Hierarchical cluster analysis for all three parallel datasets (miRNA, proteomics, mRNA) was conducted in the R software environment using the Euclidean distance measure and Ward's clustering algorithm. The prediction of miRNA and oppositely correlated protein/mRNA interactions was performed using TargetScan 6.1. GO biological process, molecular function and cellular component enrichment analysis was carried out for the DE miRNA, protein and mRNA lists via the Pathway Studio 11.3 Web interface using their Mammalian database. Differential expression (DE) profiling comparing the intestinal cell lines HT-29 and Caco-2 identified 1795 Genes, 168 Proteins and 160 miRNAs as DE between the two cell lines. At the gene level, 1084 genes were upregulated and 711 were downregulated in the Caco-2 cell line relative to the HT-29 cell line. At the protein level, 57 proteins were found to be upregulated and 111 downregulated in the Caco-2 cell line relative to the HT-29 cell line. Finally, at the miRNAs level, 104 were upregulated and 56 downregulated in the Caco-2 cell line relative to the HT-29 cell line. Gene ontology (GO) analysis of the DE mRNA identified cell adhesion, migration and ECM organization, cellular lipid

  20. Parallel-aligned GaAs nanowires with (110) orientation laterally grown on [311]B substrates via the gold-catalyzed vapor-liquid-solid mode

    International Nuclear Information System (INIS)

    Zhang Guoqiang; Tateno, Kouta; Gotoh, Hideki; Nakano, Hidetoshi

    2010-01-01

    We report parallel aligned GaAs nanowires (NWs) with (110) orientation laterally grown on [311]B substrates via the vapor-liquid-solid mode and demonstrate their controllability and growth mechanism. We control the size, density, and site of the lateral NWs by using size- and density-selective Au colloidal particles and Au dot arrays defined by electron-beam lithography. The lateral NWs grow only along the [110] and [1-bar 1-bar 0] directions and formation of the stable facets of (111)B and (001) on the sides of the lateral NWs is crucial for lateral NW growth. We clarify the growth mechanism by comparing the growth results on [311]B, (311)A, and (001) substrates and the surface energy change of lateral and freestanding NWs.

  1. MICA: Multiple interval-based curve alignment

    Science.gov (United States)

    Mann, Martin; Kahle, Hans-Peter; Beck, Matthias; Bender, Bela Johannes; Spiecker, Heinrich; Backofen, Rolf

    2018-01-01

    MICA enables the automatic synchronization of discrete data curves. To this end, characteristic points of the curves' shapes are identified. These landmarks are used within a heuristic curve registration approach to align profile pairs by mapping similar characteristics onto each other. In combination with a progressive alignment scheme, this enables the computation of multiple curve alignments. Multiple curve alignments are needed to derive meaningful representative consensus data of measured time or data series. MICA was already successfully applied to generate representative profiles of tree growth data based on intra-annual wood density profiles or cell formation data. The MICA package provides a command-line and graphical user interface. The R interface enables the direct embedding of multiple curve alignment computation into larger analyses pipelines. Source code, binaries and documentation are freely available at https://github.com/BackofenLab/MICA

  2. Evaluation of alignment error of micropore X-ray optics caused by hot plastic deformation

    Science.gov (United States)

    Numazawa, Masaki; Ishi, Daiki; Ezoe, Yuichiro; Takeuchi, Kazuma; Terada, Masaru; Fujitani, Maiko; Ishikawa, Kumi; Nakajima, Kazuo; Morishita, Kohei; Ohashi, Takaya; Mitsuda, Kazuhisa; Nakamura, Kasumi; Noda, Yusuke

    2018-06-01

    We report on the evaluation and characterization of micro-electromechanical system (MEMS) X-ray optics produced by silicon dry etching and hot plastic deformation. Sidewalls of micropores formed by etching through a silicon wafer are used as X-ray reflecting mirrors. The wafer is deformed into a spherical shape to focus parallel incidence X-rays. We quantitatively evaluated a mirror alignment error using an X-ray pencil beam (Al Kα line at 1.49 keV). The deviation angle caused only by the deformation was estimated from angular shifts of the X-ray focusing point before and after the deformation to be 2.7 ± 0.3 arcmin on average within the optics. This gives an angular resolution of 12.9 ± 1.4 arcmin in half-power diameter (HPD). The surface profile of the deformed optics measured using a NH-3Ns surface profiler (Mitaka Kohki) also indicated that the resolution was 11.4 ± 0.9 arcmin in HPD, suggesting that we can simply evaluate the alignment error caused by the hot plastic deformation.

  3. Alignment technology and applications of liquid crystal devices

    CERN Document Server

    Takatoh, Kohki; Hasegawa, Ray; Koden, Mitsushiro; Itoh, Nobuyuki; Hasegawa, Masaki

    2005-01-01

    Alignment phenomena are characteristic of liquid crystalline materials, and understanding them is critically important in understanding the essential features and behavior of liquid crystals and the performance of Liquid Crystal Devices (LCDs). Furthermore, in LCD production lines, the alignment process is of practical importance. Alignment Technologies and Applications of Liquid Crystal Devices demonstrates both the fundamental and practical aspects of alignment phenomena in liquid crystals. The physical basis of alignment phenomena is first introduced in order to aid the understanding of the various physical phenomena observed in the interface between liquid crystalline materials and alignment layer surfaces. Methods for the characterization of surfaces, which induce the alignment phenomena, and of the alignment layer itself are introduced. These methods are useful for the research of liquid crystalline materials and devices in academic research as well as in industry. In the practical sections, the alignme...

  4. Node fingerprinting: an efficient heuristic for aligning biological networks.

    Science.gov (United States)

    Radu, Alex; Charleston, Michael

    2014-10-01

    With the continuing increase in availability of biological data and improvements to biological models, biological network analysis has become a promising area of research. An emerging technique for the analysis of biological networks is through network alignment. Network alignment has been used to calculate genetic distance, similarities between regulatory structures, and the effect of external forces on gene expression, and to depict conditional activity of expression modules in cancer. Network alignment is algorithmically complex, and therefore we must rely on heuristics, ideally as efficient and accurate as possible. The majority of current techniques for network alignment rely on precomputed information, such as with protein sequence alignment, or on tunable network alignment parameters, which may introduce an increased computational overhead. Our presented algorithm, which we call Node Fingerprinting (NF), is appropriate for performing global pairwise network alignment without precomputation or tuning, can be fully parallelized, and is able to quickly compute an accurate alignment between two biological networks. It has performed as well as or better than existing algorithms on biological and simulated data, and with fewer computational resources. The algorithmic validation performed demonstrates the low computational resource requirements of NF.

  5. Effect of field-aligned-beam in parallel diffusion of energetic particles in the Earth's foreshock

    Science.gov (United States)

    Matsukiyo, S.; Nakanishi, K.; Otsuka, F.; Kis, A.; Lemperger, I.; Hada, T.

    2016-12-01

    Diffusive shock acceleration (DSA) is one of the plausible acceleration mechanisms of cosmic rays. In the standard DSA model the partial density of the accelerated particles, diffused into upstream, exponentially decreases as the distance to the shock increases. Kis et al. (GRL, 31, L20801, 2004) examined the density gradients of energetic ions upstream of the bow shock with high accuracy by using Cluster data. They estimated the diffusion coefficients of energetic ions for the event in February 18, 2003 and showed that the obtained diffusion coefficients are significantly smaller than those estimated in the past statistical study. This implies that particle acceleration at the bow shock can be more efficient than considered before. Here, we focus on the effect of the field-aligned-beam (FAB) which is often observed in the foreshock, and examine how the FAB affects the efficiency of diffusion of the energetic ions by performing test particle simulations. The upstream turbulence is given by the superposition of parallel Alfven waves with power-law energy spectrum with random phase approximation. In the spectrum we further add a peak corresponding to the waves resonantly generated by the FAB. The dependence of the diffusion coefficient on the presence of the FAB as well as total energy of the turbulence, power-law index of the turbulence, and intensity of FAB oriented waves are discussed.

  6. Parallelization Issues and Particle-In Codes.

    Science.gov (United States)

    Elster, Anne Cathrine

    1994-01-01

    "Everything should be made as simple as possible, but not simpler." Albert Einstein. The field of parallel scientific computing has concentrated on parallelization of individual modules such as matrix solvers and factorizers. However, many applications involve several interacting modules. Our analyses of a particle-in-cell code modeling charged particles in an electric field, show that these accompanying dependencies affect data partitioning and lead to new parallelization strategies concerning processor, memory and cache utilization. Our test-bed, a KSR1, is a distributed memory machine with a globally shared addressing space. However, most of the new methods presented hold generally for hierarchical and/or distributed memory systems. We introduce a novel approach that uses dual pointers on the local particle arrays to keep the particle locations automatically partially sorted. Complexity and performance analyses with accompanying KSR benchmarks, have been included for both this scheme and for the traditional replicated grids approach. The latter approach maintains load-balance with respect to particles. However, our results demonstrate it fails to scale properly for problems with large grids (say, greater than 128-by-128) running on as few as 15 KSR nodes, since the extra storage and computation time associated with adding the grid copies, becomes significant. Our grid partitioning scheme, although harder to implement, does not need to replicate the whole grid. Consequently, it scales well for large problems on highly parallel systems. It may, however, require load balancing schemes for non-uniform particle distributions. Our dual pointer approach may facilitate this through dynamically partitioned grids. We also introduce hierarchical data structures that store neighboring grid-points within the same cache -line by reordering the grid indexing. This alignment produces a 25% savings in cache-hits for a 4-by-4 cache. A consideration of the input data's effect on

  7. The rigors of aligning performance

    OpenAIRE

    Hart, Andrew; Lucas, James

    2015-01-01

    Approved for public release; distribution is unlimited This Joint Applied Project addresses what can be done within the Naval Facilities Engineering Command Northwest community to better align its goals among competing interests from various stakeholders, while balancing the operational and regulatory constraints that often conflict with stakeholder goals and objectives. As a cross-functional organization, competing interests among the various business lines, support lines, and other stake...

  8. Optics of Balloon Experimental Twin Telescope for Infrared Interferometry (BETTII): Delay Lines and Alignment

    Science.gov (United States)

    Dhabal, Arnab; Rinehart, Stephen A.; Rizzo, Maxime J.; Mundy, Lee; Fixsen, Dale; Sampler, Henry; Mentzell, Eric; Veach, Todd; Silverberg, Robert F.; Furst, Stephen; hide

    2016-01-01

    We present the optics of Balloon Experimental Twin Telescope for Infrared Interferometry (BETTII) as it gets ready for launch. BETTII is an 8-meter baseline far-infrared (30-90 microns) interferometer mission with capabilities of spatially resolved spectroscopy aimed at studying star formation and galaxy evolution. The instrument collects light from its two arms, makes them interfere, divides them into two science channels (30-50 microns and 60-90 microns), and focuses them onto the detectors. It also separates out the NIR light (1-2.5 microns) and uses it for tip-tilt corrections of the telescope pointing. Currently, all the optical elements have been fabricated, heat treated, coated appropriately and are mounted on their respective assemblies. We are presenting the optical design challenges for such a balloon borne spatio-spectral interferometer, and discuss how they have been mitigated. The warm and cold delay lines are an important part of this optics train. The warm delay line corrects for path length differences between the left and the right arm due to balloon pendulation, while the cold delay line is aimed at introducing a systematic path length difference, thereby generating our interferograms from where we can derive information about the spectra. The details of their design and the results of the testing of these opto-mechanical parts are also discussed. The sensitivities of different optical elements on the interferograms produced have been determined with the help of simulations using FRED software package. Accordingly, an alignment plan is drawn up which makes use of a laser tracker, a CMM, theodolites and a LUPI interferometer.

  9. Aligned carbon nanotubes. Physics, concepts, fabrication and devices

    Energy Technology Data Exchange (ETDEWEB)

    Ren, Zhifeng; Lan, Yucheng [Boston College, Chestnut Hill, MA (United States). Dept. of Physics; Wang, Yang [South China Normal Univ. Guangzhou (China). Inst. for Advanced Materials

    2013-07-01

    This book gives a survey of the physics and fabrication of carbon nanotubes and their applications in optics, electronics, chemistry and biotechnology. It focuses on the structural characterization of various carbon nanotubes, fabrication of vertically or parallel aligned carbon nanotubes on substrates or in composites, physical properties for their alignment, and applications of aligned carbon nanotubes in field emission, optical antennas, light transmission, solar cells, chemical devices, bio-devices, and many others. Major fabrication methods are illustrated in detail, particularly the most widely used PECVD growth technique on which various device integration schemes are based, followed by applications such as electrical interconnects, nanodiodes, optical antennas, and nanocoax solar cells, whereas current limitations and challenges are also be discussed to lay the foundation for future developments.

  10. Accelerator Technology: Geodesy and Alignment for Particle Accelerators

    CERN Document Server

    Missiaen, D

    2013-01-01

    This document is part of Subvolume C 'Accelerators and Colliders' of Volume 21 'Elementary Particles' of Landolt-Börnstein - Group I 'Elementary Particles, Nuclei and Atoms'. It contains the the Section '8.9 Geodesy and Alignment for Particle Accelerators' of the Chapter '8 Accelerator Technology' with the content: 8.9 Geodesy and Alignment for Particle Accelerators 8.9.1 Introduction 8.9.2 Reference and Co-ordinate Systems 8.9.3 Definition of the Beam Line on the Accelerator Site 8.9.4 Geodetic Network 8.9.5 Tunnel Preliminary Works 8.9.6 The Alignment References 8.9.7 Alignment of Accelerator Components 8.9.8 Permanent Monitoring and Remote Alignment of Low Beta Quadrupoles 8.9.9 Alignment of Detector Components

  11. Field Emission of ITO-Coated Vertically Aligned Nanowire Array.

    KAUST Repository

    Lee, Changhwa

    2010-04-29

    An indium tin oxide (ITO)-coated vertically aligned nanowire array is fabricated, and the field emission characteristics of the nanowire array are investigated. An array of vertically aligned nanowires is considered an ideal structure for a field emitter because of its parallel orientation to the applied electric field. In this letter, a vertically aligned nanowire array is fabricated by modified conventional UV lithography and coated with 0.1-μm-thick ITO. The turn-on electric field intensity is about 2.0 V/μm, and the field enhancement factor, β, is approximately 3,078 when the gap for field emission is 0.6 μm, as measured with a nanomanipulator in a scanning electron microscope.

  12. Field Emission of ITO-Coated Vertically Aligned Nanowire Array.

    KAUST Repository

    Lee, Changhwa; Lee, Seokwoo; Lee, Seung S

    2010-01-01

    An indium tin oxide (ITO)-coated vertically aligned nanowire array is fabricated, and the field emission characteristics of the nanowire array are investigated. An array of vertically aligned nanowires is considered an ideal structure for a field emitter because of its parallel orientation to the applied electric field. In this letter, a vertically aligned nanowire array is fabricated by modified conventional UV lithography and coated with 0.1-μm-thick ITO. The turn-on electric field intensity is about 2.0 V/μm, and the field enhancement factor, β, is approximately 3,078 when the gap for field emission is 0.6 μm, as measured with a nanomanipulator in a scanning electron microscope.

  13. Automated alignment of a 10-kJ laser

    International Nuclear Information System (INIS)

    Partridge, R.E.

    1979-01-01

    The complex task of aligning helios, the 10-kilojoule carbon-dioxide laser, built for fusion research at the Los Alamos Scientific Laboratory, requires computer control of steering mirrors and error sensors. The control system is a three-level minicomputer and microprocessor hierarchy which automatically aligns each of the 40 beam-line sections

  14. TMRG studies on spin alignment in molecule-based ferrimagnetics [rapid communication

    Science.gov (United States)

    Liu, Q. M.; Yao, K. L.; Liu, Z. L.

    2005-05-01

    A physical picture of spin alignment in organic molecule-based ferrimagnets is presented from studying the thermal effective magnetic moment of the sublattice by use of the transfer matrix renormalization group. We conclude that the classical antiparallel spin alignment is not the most stable state. The three-spin system tends to parallel alignment when the exchange interaction between the biradical and the monoradical molecules is much weaker than that within the biradical, which can result in the decrease of the effective magnetic moment upon lowering the temperature. More importantly, we give the theoretical evidence that even the antiparallel spin alignment in the biradical monoradical alternating chain does not necessarily lead to ferrimagnetic spin ordering due to the formation of the spin singlet pairs, which suppresses the ferrimagnetic spin alignment.

  15. SF-FDTD analysis of a predictive physical model for parallel aligned liquid crystal devices

    Science.gov (United States)

    Márquez, Andrés.; Francés, Jorge; Martínez, Francisco J.; Gallego, Sergi; Alvarez, Mariela L.; Calzado, Eva M.; Pascual, Inmaculada; Beléndez, Augusto

    2017-08-01

    Recently we demonstrated a novel and simplified model enabling to calculate the voltage dependent retardance provided by parallel aligned liquid crystal devices (PA-LCoS) for a very wide range of incidence angles and any wavelength in the visible. To our knowledge it represents the most simplified approach still showing predictive capability. Deeper insight into the physics behind the simplified model is necessary to understand if the parameters in the model are physically meaningful. Since the PA-LCoS is a black-box where we do not have information about the physical parameters of the device, we cannot perform this kind of analysis using the experimental retardance measurements. In this work we develop realistic simulations for the non-linear tilt of the liquid crystal director across the thickness of the liquid crystal layer in the PA devices. We consider these profiles to have a sine-like shape, which is a good approximation for typical ranges of applied voltage in commercial PA-LCoS microdisplays. For these simulations we develop a rigorous method based on the split-field finite difference time domain (SF-FDTD) technique which provides realistic retardance values. These values are used as the experimental measurements to which the simplified model is fitted. From this analysis we learn that the simplified model is very robust, providing unambiguous solutions when fitting its parameters. We also learn that two of the parameters in the model are physically meaningful, proving a useful reverse-engineering approach, with predictive capability, to probe into internal characteristics of the PA-LCoS device.

  16. Optical alignment techniques for line-imaging velocity interferometry and line-imaging self-emulsion of targets at the National Ignition Facility (NIF)

    International Nuclear Information System (INIS)

    Malone, Robert M.; Frogget, Brent C.; Kaufman, Morris I.; Tunnell, Thomas W.; Guyton, Robert L.; Reinbachs, Imants P.; Watts, Phillip W.

    2007-01-01

    The National Ignition Facility (NIF) requires optical diagnostics for measuring shock velocities in shock physics experiments. The Velocity Interferometer System for Any Reflector (VISAR) measures shock velocities, shock breakout times, and emission of 1- to 5-mm targets at a location remote to the NIF target chamber. Three optical systems using the same vacuum chamber port each have a total track of 69 feet. All optical lenses are on kinematic mounts or sliding rails, enabling pointing accuracy of the optical axis to be checked. Counter-propagating laser beams (orange and red) align these diagnostics to a listing of tolerances. The orange alignment laser is introduced at the entrance to the two-level interferometer table and passes forward through the optical systems to the recording streak cameras. The red alignment laser is introduced in front of the recording streak cameras and passes in the reverse direction through all optical elements, out of the interferometer table, eventually reaching the target chamber center. Red laser wavelength is selected to be at the 50 percent reflection point of a special beamsplitter used to separate emission light from the Doppler-shifted interferometer light. Movable aperture cards, placed before and after lens groups, show the spread of alignments spots created by the orange and red alignment lasers. Optical elements include 1- to 15-inch-diameter mirrors, lenses with up to 10.5-inch diameters, beamsplitters, etalons, dove prisms, filters, and pellicles. Alignment of more than 75 optical elements must be verified before each target shot. Archived images from eight alignment cameras prove proper alignment before each shot

  17. DIDA: Distributed Indexing Dispatched Alignment.

    Directory of Open Access Journals (Sweden)

    Hamid Mohamadi

    Full Text Available One essential application in bioinformatics that is affected by the high-throughput sequencing data deluge is the sequence alignment problem, where nucleotide or amino acid sequences are queried against targets to find regions of close similarity. When queries are too many and/or targets are too large, the alignment process becomes computationally challenging. This is usually addressed by preprocessing techniques, where the queries and/or targets are indexed for easy access while searching for matches. When the target is static, such as in an established reference genome, the cost of indexing is amortized by reusing the generated index. However, when the targets are non-static, such as contigs in the intermediate steps of a de novo assembly process, a new index must be computed for each run. To address such scalability problems, we present DIDA, a novel framework that distributes the indexing and alignment tasks into smaller subtasks over a cluster of compute nodes. It provides a workflow beyond the common practice of embarrassingly parallel implementations. DIDA is a cost-effective, scalable and modular framework for the sequence alignment problem in terms of memory usage and runtime. It can be employed in large-scale alignments to draft genomes and intermediate stages of de novo assembly runs. The DIDA source code, sample files and user manual are available through http://www.bcgsc.ca/platform/bioinfo/software/dida. The software is released under the British Columbia Cancer Agency License (BCCA, and is free for academic use.

  18. Scattering of field-aligned beam ions upstream of Earth's bow shock

    Directory of Open Access Journals (Sweden)

    A. Kis

    2007-03-01

    Full Text Available Field-aligned beams are known to originate from the quasi-perpendicular side of the Earth's bow shock, while the diffuse ion population consists of accelerated ions at the quasi-parallel side of the bow shock. The two distinct ion populations show typical characteristics in their velocity space distributions. By using particle and magnetic field measurements from one Cluster spacecraft we present a case study when the two ion populations are observed simultaneously in the foreshock region during a high Mach number, high solar wind velocity event. We present the spatial-temporal evolution of the field-aligned beam ion distribution in front of the Earth's bow shock, focusing on the processes in the deep foreshock region, i.e. on the quasi-parallel side. Our analysis demonstrates that the scattering of field-aligned beam (FAB ions combined with convection by the solar wind results in the presence of lower-energy, toroidal gyrating ions at positions deeper in the foreshock region which are magnetically connected to the quasi-parallel bow shock. The gyrating ions are superposed onto a higher energy diffuse ion population. It is suggested that the toroidal gyrating ion population observed deep in the foreshock region has its origins in the FAB and that its characteristics are correlated with its distance from the FAB, but is independent on distance to the bow shock along the magnetic field.

  19. Micro-vision servo control of a multi-axis alignment system for optical fiber assembly

    International Nuclear Information System (INIS)

    Chen, Weihai; Yu, Fei; Qu, Jianliang; Chen, Wenjie; Zhang, Jianbin

    2017-01-01

    This paper describes a novel optical fiber assembly system featuring a multi-axis alignment function based on micro-vision feedback control. It consists of an active parallel alignment mechanism, a passive compensation mechanism, a micro-gripper and a micro-vision servo control system. The active parallel alignment part is a parallelogram-based design with remote-center-of-motion (RCM) function to achieve precise rotation without fatal lateral motion. The passive mechanism, with five degrees of freedom (5-DOF), is used to implement passive compensation for multi-axis errors. A specially designed 1-DOF micro-gripper mounted onto the active parallel alignment platform is adopted to grasp and rotate the optical fiber. A micro-vision system equipped with two charge-coupled device (CCD) cameras is introduced to observe the small field of view and obtain multi-axis errors for servo feedback control. The two CCD cameras are installed in an orthogonal arrangement—thus the errors can be easily measured via the captured images. Meanwhile, a series of tracking and measurement algorithms based on specific features of the target objects are developed. Details of the force and displacement sensor information acquisition in the assembly experiment are also provided. An experiment demonstrates the validity of the proposed visual algorithm by achieving the task of eliminating errors and inserting an optical fiber to the U-groove accurately. (paper)

  20. 3C 254: the alignment effect and unification schemes

    Science.gov (United States)

    Bremer, M. N.

    1997-01-01

    3C 254 is a radio-loud quasar at z=0.734. Optical line and continuum emission from the underlying galaxy is clearly extended and aligned with the radio axis; the object shows the so-called `alignment effect' which is often seen in powerful radio galaxies. This is the clearest case yet of the continuum alignment effect in a radio-loud quasar. The object is one of the most lobe-dominated 3C quasars; the significance of the aligned emission in this source is discussed in terms of orientation-based unification schemes for radio-loud quasars and radio galaxies. 3C 254 is a very asymmetric radio source and it is shown that the radio structure on the side with the shortest nucleus-hotspot distance is interacting with the emission-line gas surrounding the quasar. It is also shown that the quasar is surrounded by an overdensity of faint objects, consistent with a cluster or group of galaxies around the object.

  1. Flux-line-cutting losses in type-II superconductors

    International Nuclear Information System (INIS)

    Clem, J.R.

    1982-01-01

    Energy dissipation associated with flux-line cutting (intersection and cross-joining of adjacent nonparallel vortices) is considered theoretically. The flux-line-cutting contribution to the dissipation per unit volume, arising from mutual annihilation of transverse magnetic flux, is identified as J/sub parallel/xE/sub parallel/, where J/sub parallel/ and E/sub parallel/ are the components of the current density and the electric field parallel to the magnetic induction. The dynamical behavior of the magnetic structure at the flux-line-cutting threshold is shown to be governed by a special critical-state model similar to that proposed by previous authors. The resulting flux-line-cutting critical-state model, characterized in planar geometry by a parallel critical current density J/sub c/parallel or a critical angle gradient k/sub c/, is used to calculate predicted hysteretic ac flux-line-cutting losses in type-II superconductors in which the flux pinning is weak. The relation of the theory to previous experiments is discussed

  2. Importance of the alignment of polar π conjugated molecules inside carbon nanotubes in determining second-order non-linear optical properties.

    Science.gov (United States)

    Yumura, Takashi; Yamamoto, Wataru

    2017-09-20

    We employed density functional theory (DFT) calculations with dispersion corrections to investigate energetically preferred alignments of certain p,p'-dimethylaminonitrostilbene (DANS) molecules inside an armchair (m,m) carbon nanotube (n × DANS@(m,m)), where the number of inner molecules (n) is no greater than 3. Here, three types of alignments of DANS are considered: a linear alignment in a parallel fashion and stacking alignments in parallel and antiparallel fashions. According to DFT calculations, a threshold tube diameter for containing DANS molecules in linear or stacking alignments was found to be approximately 1.0 nm. Nanotubes with diameters smaller than 1.0 nm result in the selective formation of linearly aligned DANS molecules due to strong confinement effects within the nanotubes. By contrast, larger diameter nanotubes allow DANS molecules to align in a stacking and linear fashion. The type of alignment adopted by the DANS molecules inside a nanotube is responsible for their second-order non-linear optical properties represented by their static hyperpolarizability (β 0 values). In fact, we computed β 0 values of DANS assemblies taken from optimized n × DANS@(m,m) structures, and their values were compared with those of a single DANS molecule. DFT calculations showed that β 0 values of DANS molecules depend on their alignment, which decrease in the following order: linear alignment > parallel stacking alignment > antiparallel stacking alignment. In particular, a linear alignment has a β 0 value more significant than that of the same number of isolated molecules. Therefore, the linear alignment of DANS molecules, which is only allowed inside smaller diameter nanotubes, can strongly enhance their second-order non-linear optical properties. Since the nanotube confinement determines the alignment of DANS molecules, a restricted nanospace can be utilized to control their second-order non-linear optical properties. These DFT findings can assist in the

  3. Scale dependence of the alignment between strain rate and rotation in turbulent shear flow

    KAUST Repository

    Fiscaletti, D.

    2016-10-24

    The scale dependence of the statistical alignment tendencies of the eigenvectors of the strain-rate tensor e(i), with the vorticity vector omega, is examined in the self-preserving region of a planar turbulent mixing layer. Data from a direct numerical simulation are filtered at various length scales and the probability density functions of the magnitude of the alignment cosines between the two unit vectors vertical bar e(i) . (omega) over cap vertical bar are examined. It is observed that the alignment tendencies are insensitive to the concurrent large-scale velocity fluctuations, but are quantitatively affected by the nature of the concurrent large-scale velocity-gradient fluctuations. It is confirmed that the small-scale (local) vorticity vector is preferentially aligned in parallel with the large-scale (background) extensive strain-rate eigenvector e(1), in contrast to the global tendency for omega to be aligned in parallelwith the intermediate strain-rate eigenvector [Hamlington et al., Phys. Fluids 20, 111703 (2008)]. When only data from regions of the flow that exhibit strong swirling are included, the so-called high-enstrophy worms, the alignment tendencies are exaggerated with respect to the global picture. These findings support the notion that the production of enstrophy, responsible for a net cascade of turbulent kinetic energy from large scales to small scales, is driven by vorticity stretching due to the preferential parallel alignment between omega and nonlocal e(1) and that the strongly swirling worms are kinematically significant to this process.

  4. Scale dependence of the alignment between strain rate and rotation in turbulent shear flow

    KAUST Repository

    Fiscaletti, D.; Elsinga, G. E.; Attili, Antonio; Bisetti, Fabrizio; Buxton, O. R. H.

    2016-01-01

    The scale dependence of the statistical alignment tendencies of the eigenvectors of the strain-rate tensor e(i), with the vorticity vector omega, is examined in the self-preserving region of a planar turbulent mixing layer. Data from a direct numerical simulation are filtered at various length scales and the probability density functions of the magnitude of the alignment cosines between the two unit vectors vertical bar e(i) . (omega) over cap vertical bar are examined. It is observed that the alignment tendencies are insensitive to the concurrent large-scale velocity fluctuations, but are quantitatively affected by the nature of the concurrent large-scale velocity-gradient fluctuations. It is confirmed that the small-scale (local) vorticity vector is preferentially aligned in parallel with the large-scale (background) extensive strain-rate eigenvector e(1), in contrast to the global tendency for omega to be aligned in parallelwith the intermediate strain-rate eigenvector [Hamlington et al., Phys. Fluids 20, 111703 (2008)]. When only data from regions of the flow that exhibit strong swirling are included, the so-called high-enstrophy worms, the alignment tendencies are exaggerated with respect to the global picture. These findings support the notion that the production of enstrophy, responsible for a net cascade of turbulent kinetic energy from large scales to small scales, is driven by vorticity stretching due to the preferential parallel alignment between omega and nonlocal e(1) and that the strongly swirling worms are kinematically significant to this process.

  5. Treatment management between orthodontists and general practitioners performing clear aligner therapy.

    Science.gov (United States)

    Best, Alexandra D; Shroff, Bhavna; Carrico, Caroline K; Lindauer, Steven J

    2017-05-01

    To investigate differences in case selection, treatment management, and aligner treatment expertise between orthodontists and general practitioners. A parallel pair of original surveys with three sections (case selection, treatment management, and demographics) was sent to orthodontists (N = 1000) and general dentists (N = 1000) who were providers of aligner treatment. Orthodontists had treated significantly more patients with aligners, had treated more patients with aligners in the previous 12 months, and had received more aligner training than general dentists (P aligner case confidence between orthodontists and general dentists for several malocclusions. General dentists were more confident than orthodontists in treating deep bite, severe crowding, and Class II malocclusions with aligners (P ≤ .0001). Significant differences were also found for all treatment management techniques except interproximal reduction. There was a significant difference in case selection, treatment management, and aligner expertise between orthodontists and general dentists, although the differences in case selection were small. Overall, it was shown that orthodontists and general dentists elected to treat a variety of moderate to severe malocclusions with aligners but with different utilization of recommended auxiliaries, perhaps demonstrating a difference in treatment goals.

  6. Multi-objective optimization algorithms for mixed model assembly line balancing problem with parallel workstations

    Directory of Open Access Journals (Sweden)

    Masoud Rabbani

    2016-12-01

    Full Text Available This paper deals with mixed model assembly line (MMAL balancing problem of type-I. In MMALs several products are made on an assembly line while the similarity of these products is so high. As a result, it is possible to assemble several types of products simultaneously without any additional setup times. The problem has some particular features such as parallel workstations and precedence constraints in dynamic periods in which each period also effects on its next period. The research intends to reduce the number of workstations and maximize the workload smoothness between workstations. Dynamic periods are used to determine all variables in different periods to achieve efficient solutions. A non-dominated sorting genetic algorithm (NSGA-II and multi-objective particle swarm optimization (MOPSO are used to solve the problem. The proposed model is validated with GAMS software for small size problem and the performance of the foregoing algorithms is compared with each other based on some comparison metrics. The NSGA-II outperforms MOPSO with respect to some comparison metrics used in this paper, but in other metrics MOPSO is better than NSGA-II. Finally, conclusion and future research is provided.

  7. Analisa Pengaruh Parallel-Misalignment dan Tingkat Getaran yang Terjadi pada Pulley Depericarper Fan

    OpenAIRE

    Situmorang, Lastri

    2016-01-01

    Depericarper fan consists of two pulleys, one as a driver and the other as a driven. The construction of the two pulleys that is not aligned can cause two pulleys run into parallel-misalignment.The parallel-misalignment pulley causing of vibration that can influence machine performance and decrease of power transmission. The purpose of the research are to known of influence parallel-misalignment against vibrations and rotation that occurs on depericarper fan. The research is done by using las...

  8. Theory of the deformation of aligned polyethylene.

    Science.gov (United States)

    Hammad, A; Swinburne, T D; Hasan, H; Del Rosso, S; Iannucci, L; Sutton, A P

    2015-08-08

    Solitons are proposed as the agents of plastic and viscoelastic deformation in aligned polyethylene. Interactions between straight, parallel molecules are mapped rigorously onto the Frenkel-Kontorova model. It is shown that these molecular interactions distribute an applied load between molecules, with a characteristic transfer length equal to the soliton width. Load transfer leads to the introduction of tensile and compressive solitons at the chain ends to mark the onset of plasticity at a well-defined yield stress, which is much less than the theoretical pull-out stress. Interaction energies between solitons and an equation of motion for solitons are derived. The equation of motion is based on Langevin dynamics and the fluctuation-dissipation theorem and it leads to the rigorous definition of an effective mass for solitons. It forms the basis of a soliton dynamics in direct analogy to dislocation dynamics. Close parallels are drawn between solitons in aligned polymers and dislocations in crystals, including the configurational force on a soliton. The origins of the strain rate and temperature dependencies of the viscoelastic behaviour are discussed in terms of the formation energy of solitons. A failure mechanism is proposed involving soliton condensation under a tensile load.

  9. Analysis of Parallel Algorithms on SMP Node and Cluster of Workstations Using Parallel Programming Models with New Tile-based Method for Large Biological Datasets.

    Science.gov (United States)

    Shrimankar, D D; Sathe, S R

    2016-01-01

    Sequence alignment is an important tool for describing the relationships between DNA sequences. Many sequence alignment algorithms exist, differing in efficiency, in their models of the sequences, and in the relationship between sequences. The focus of this study is to obtain an optimal alignment between two sequences of biological data, particularly DNA sequences. The algorithm is discussed with particular emphasis on time, speedup, and efficiency optimizations. Parallel programming presents a number of critical challenges to application developers. Today's supercomputer often consists of clusters of SMP nodes. Programming paradigms such as OpenMP and MPI are used to write parallel codes for such architectures. However, the OpenMP programs cannot be scaled for more than a single SMP node. However, programs written in MPI can have more than single SMP nodes. But such a programming paradigm has an overhead of internode communication. In this work, we explore the tradeoffs between using OpenMP and MPI. We demonstrate that the communication overhead incurs significantly even in OpenMP loop execution and increases with the number of cores participating. We also demonstrate a communication model to approximate the overhead from communication in OpenMP loops. Our results are astonishing and interesting to a large variety of input data files. We have developed our own load balancing and cache optimization technique for message passing model. Our experimental results show that our own developed techniques give optimum performance of our parallel algorithm for various sizes of input parameter, such as sequence size and tile size, on a wide variety of multicore architectures.

  10. Analysis of Parallel Algorithms on SMP Node and Cluster of Workstations Using Parallel Programming Models with New Tile-based Method for Large Biological Datasets

    Science.gov (United States)

    Shrimankar, D. D.; Sathe, S. R.

    2016-01-01

    Sequence alignment is an important tool for describing the relationships between DNA sequences. Many sequence alignment algorithms exist, differing in efficiency, in their models of the sequences, and in the relationship between sequences. The focus of this study is to obtain an optimal alignment between two sequences of biological data, particularly DNA sequences. The algorithm is discussed with particular emphasis on time, speedup, and efficiency optimizations. Parallel programming presents a number of critical challenges to application developers. Today’s supercomputer often consists of clusters of SMP nodes. Programming paradigms such as OpenMP and MPI are used to write parallel codes for such architectures. However, the OpenMP programs cannot be scaled for more than a single SMP node. However, programs written in MPI can have more than single SMP nodes. But such a programming paradigm has an overhead of internode communication. In this work, we explore the tradeoffs between using OpenMP and MPI. We demonstrate that the communication overhead incurs significantly even in OpenMP loop execution and increases with the number of cores participating. We also demonstrate a communication model to approximate the overhead from communication in OpenMP loops. Our results are astonishing and interesting to a large variety of input data files. We have developed our own load balancing and cache optimization technique for message passing model. Our experimental results show that our own developed techniques give optimum performance of our parallel algorithm for various sizes of input parameter, such as sequence size and tile size, on a wide variety of multicore architectures. PMID:27932868

  11. ALIGNMENTS OF GROUP GALAXIES WITH NEIGHBORING GROUPS

    International Nuclear Information System (INIS)

    Wang Yougang; Chen Xuelei; Park, Changbom; Yang Xiaohu; Choi, Yun-Young

    2009-01-01

    Using a sample of galaxy groups found in the Sloan Digital Sky Survey Data Release 4, we measure the following four types of alignment signals: (1) the alignment between the distributions of the satellites of each group relative to the direction of the nearest neighbor group (NNG); (2) the alignment between the major axis direction of the central galaxy of the host group (HG) and the direction of the NNG; (3) the alignment between the major axes of the central galaxies of the HG and the NNG; and (4) the alignment between the major axes of the satellites of the HG and the direction of the NNG. We find strong signal of alignment between the satellite distribution and the orientation of central galaxy relative to the direction of the NNG, even when the NNG is located beyond 3r vir of the host group. The major axis of the central galaxy of the HG is aligned with the direction of the NNG. The alignment signals are more prominent for groups that are more massive and with early-type central galaxies. We also find that there is a preference for the two major axes of the central galaxies of the HG and NNG to be parallel for the system with both early central galaxies, however, not for the systems with both late-type central galaxies. For the orientation of satellite galaxies, we do not find any significant alignment signals relative to the direction of the NNG. From these four types of alignment measurements, we conclude that the large-scale environment traced by the nearby group affects primarily the shape of the host dark matter halo, and hence also affects the distribution of satellite galaxies and the orientation of central galaxies. In addition, the NNG directly affects the distribution of the satellite galaxies by inducing asymmetric alignment signals, and the NNG at very small separation may also contribute a second-order impact on the orientation of the central galaxy in the HG.

  12. The Poisson alignment reference system implementation at the Advanced Photon Source

    International Nuclear Information System (INIS)

    Feier, I.

    1998-01-01

    The Poisson spot was established using a collimated laser beam from a 3-mW diode laser. It was monitored on a quadrant detector and found to be very sensitive to vibration and air disturbances. Therefore, for future work we strongly recommend a sealed vacuum tube in which the Poisson line may be propagated. A digital single-axis feedback system was employed to generate an straight line reference (SLR) on the X axis. Pointing accuracy was better than 8 ± 2 microns at a distance of 5 m. The digital system was found to be quite slow with a maximum bandwidth of 47 ± 9 Hz. Slow drifts were easily corrected but any vibration over 5 Hz was not. We recommend an analog proportional-integral-derivative (PID) controller for high bandwidth and smooth operation of the kinematic mirror. Although the Poisson alignment system (PAS) at the Advanced Photon Source is still in its infancy, it already shows great promise as a possible alignment system for the low-energy undulator test line (LEUTL). Since components such as wigglers and quadruples will initially be aligned with respect to each other using conventional means and mounted on some kind of rigid rail, the goal would be to align six to ten such rails over a distance of about 30 m. The PAS could be used to align these rails by mounting a sphere at the joint between two rails. These spheres would need to be in a vacuum pipe to eliminate the refractive effects of air. Each sphere would not be attached to either rail but instead to a flange connecting the vacuum pipes of each rail. Thus the whole line would be made up of straight, rigid segments that could be aligned by moving the joints. Each sphere would have its own detector, allowing the operators to actively monitor the position of each joint and therefore the overall alignment of the system

  13. Shape, size, velocity and field-aligned currents of dayside plasma injections: a multi-altitude study

    Directory of Open Access Journals (Sweden)

    A. Marchaudon

    2009-03-01

    Full Text Available On 20 February 2005, Cluster in the outer magnetosphere and Double Star-2 (TC-2 at mid-altitude are situated in the vicinity of the northern cusp/mantle, with Cluster moving sunward and TC-2 anti-sunward. Their magnetic footprints come very close together at about 15:28 UT, over the common field-of-view of SuperDARN radars. Thanks to this conjunction, we determine the velocity, the transverse sizes, perpendicular and parallel to this velocity, and the shape of three magnetic flux tubes of magnetosheath plasma injection. The velocity of the structures determined from the Cluster four-spacecraft timing analysis is almost purely antisunward, in contrast with the antisunward and duskward convection velocity inside the flux tubes. The transverse sizes are defined from the Cluster-TC-2 separation perpendicular to the magnetic field, and from the time spent by a Cluster spacecraft in one structure; they are comprised between 0.6 and 2 RE in agreement with previous studies. Finally, using a comparison between the eigenvectors deduced from a variance analysis of the magnetic perturbation at the four Cluster and at TC-2, we show that the upstream side of the injection flux tubes is magnetically well defined, with even a concave front for the third one giving a bean-like shape, whereas the downstream side is far more turbulent. We also realise the first quantitative comparison between field-aligned currents at Cluster calculated with the curlometer technique and with the single-spacecraft method, assuming infinite parallel current sheets and taking into account the velocity of the injection flux tubes. The results agree nicely, confirming the validity of both methods. Finally, we compare the field-aligned current distribution of the three injection flux tubes at the altitudes of Cluster and TC-2. Both profiles are fairly similar, with mainly a pair of opposite field-aligned currents, upward at low-latitude and downward at high-latitude. In terms of

  14. Enhancement of the guide field during the current sheet formation in the three-dimensional magnetic configuration with an X line

    International Nuclear Information System (INIS)

    Frank, Anna; Bugrov, Sergey; Markov, Vladimir

    2009-01-01

    Results are presented from studies of the formation of current sheets during exciting a current aligned with the X line of the 3D magnetic configuration, in the CS-3D device. Enhancement of the guide field (parallel to the X line) was directly observed for the first time, on the basis of magnetic measurements. After the current sheet formation, the guide field inside the sheet exceeds its initial value, as well as the field outside. It is convincingly demonstrated that an enhancement of the guide field is due to its transportation by plasma flows on the early stage of the sheet formation. The in-plane plasma currents, which produce the excess guide field, are comparable to the total current along the X line that initiates the sheet itself.

  15. Study and Development of a Laser Based Alignment System

    CERN Multimedia

    Stern, G

    2014-01-01

    CLIC (Compact Linear Collider) has tight requirements regarding pre-alignment of beam related components: 10 µm accuracy over a sliding window of 200 m along the 20 km of linac. To perform such an alignment, a new system is proposed combining laser beam as straight line reference and camera/shutter assemblies as sensors. The poster describes the alignment system and shows results regarding laser pointing stability with respect to time, shutter type, distance and environment. These results give a frame for future building and calibrating of sensors.

  16. Egocentric and allocentric alignment tasks are affected by otolith input.

    Science.gov (United States)

    Tarnutzer, Alexander A; Bockisch, Christopher J; Olasagasti, Itsaso; Straumann, Dominik

    2012-06-01

    Gravicentric visual alignments become less precise when the head is roll-tilted relative to gravity, which is most likely due to decreasing otolith sensitivity. To align a luminous line with the perceived gravity vector (gravicentric task) or the perceived body-longitudinal axis (egocentric task), the roll orientation of the line on the retina and the torsional position of the eyes relative to the head must be integrated to obtain the line orientation relative to the head. Whether otolith input contributes to egocentric tasks and whether the modulation of variability is restricted to vision-dependent paradigms is unknown. In nine subjects we compared precision and accuracy of gravicentric and egocentric alignments in various roll positions (upright, 45°, and 75° right-ear down) using a luminous line (visual paradigm) in darkness. Trial-to-trial variability doubled for both egocentric and gravicentric alignments when roll-tilted. Two mechanisms might explain the roll-angle-dependent modulation in egocentric tasks: 1) Modulating variability in estimated ocular torsion, which reflects the roll-dependent precision of otolith signals, affects the precision of estimating the line orientation relative to the head; this hypothesis predicts that variability modulation is restricted to vision-dependent alignments. 2) Estimated body-longitudinal reflects the roll-dependent variability of perceived earth-vertical. Gravicentric cues are thereby integrated regardless of the task's reference frame. To test the two hypotheses the visual paradigm was repeated using a rod instead (haptic paradigm). As with the visual paradigm, precision significantly decreased with increasing head roll for both tasks. These findings propose that the CNS integrates input coded in a gravicentric frame to solve egocentric tasks. In analogy to gravicentric tasks, where trial-to-trial variability is mainly influenced by the properties of the otolith afferents, egocentric tasks may also integrate

  17. Microwave conductance properties of aligned multiwall carbon nanotube textile sheets

    Energy Technology Data Exchange (ETDEWEB)

    Brown, Brian L. [Univ. of Texas, Dallas, TX (United States); Martinez, Patricia [Univ. of Texas, Dallas, TX (United States); Zakhidov, Anvar A. [Univ. of Texas, Dallas, TX (United States); Shaner, Eric A. [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Lee, Mark [Univ. of Texas, Dallas, TX (United States)

    2015-07-06

    Understanding the conductance properties of multi-walled carbon nanotube (MWNT) textile sheets in the microwave regime is essential for their potential use in high-speed and high-frequency applications. To expand current knowledge, complex high-frequency conductance measurements from 0.01 to 50 GHz and across temperatures from 4.2 K to 300 K and magnetic fields up to 2 T were made on textile sheets of highly aligned MWNTs with strand alignment oriented both parallel and perpendicular to the microwave electric field polarization. Sheets were drawn from 329 and 520 μm high MWNT forests that resulted in different DC resistance anisotropy. For all samples, the microwave conductance can be modeled approximately by a shunt capacitance in parallel with a frequency-independent conductance, but with no inductive contribution. Finally, this is consistent with diffusive Drude conduction as the primary transport mechanism up to 50 GHz. Further, it is found that the microwave conductance is essentially independent of both temperature and magnetic field.

  18. High-voltage isolation transformer for sub-nanosecond rise time pulses constructed with annular parallel-strip transmission lines.

    Science.gov (United States)

    Homma, Akira

    2011-07-01

    A novel annular parallel-strip transmission line was devised to construct high-voltage high-speed pulse isolation transformers. The transmission lines can easily realize stable high-voltage operation and good impedance matching between primary and secondary circuits. The time constant for the step response of the transformer was calculated by introducing a simple low-frequency equivalent circuit model. Results show that the relation between the time constant and low-cut-off frequency of the transformer conforms to the theory of the general first-order linear time-invariant system. Results also show that the test transformer composed of the new transmission lines can transmit about 600 ps rise time pulses across the dc potential difference of more than 150 kV with insertion loss of -2.5 dB. The measured effective time constant of 12 ns agreed exactly with the theoretically predicted value. For practical applications involving the delivery of synchronized trigger signals to a dc high-voltage electron gun station, the transformer described in this paper exhibited advantages over methods using fiber optic cables for the signal transfer system. This transformer has no jitter or breakdown problems that invariably occur in active circuit components.

  19. Mapping robust parallel multigrid algorithms to scalable memory architectures

    Science.gov (United States)

    Overman, Andrea; Vanrosendale, John

    1993-01-01

    The convergence rate of standard multigrid algorithms degenerates on problems with stretched grids or anisotropic operators. The usual cure for this is the use of line or plane relaxation. However, multigrid algorithms based on line and plane relaxation have limited and awkward parallelism and are quite difficult to map effectively to highly parallel architectures. Newer multigrid algorithms that overcome anisotropy through the use of multiple coarse grids rather than relaxation are better suited to massively parallel architectures because they require only simple point-relaxation smoothers. In this paper, we look at the parallel implementation of a V-cycle multiple semicoarsened grid (MSG) algorithm on distributed-memory architectures such as the Intel iPSC/860 and Paragon computers. The MSG algorithms provide two levels of parallelism: parallelism within the relaxation or interpolation on each grid and across the grids on each multigrid level. Both levels of parallelism must be exploited to map these algorithms effectively to parallel architectures. This paper describes a mapping of an MSG algorithm to distributed-memory architectures that demonstrates how both levels of parallelism can be exploited. The result is a robust and effective multigrid algorithm for distributed-memory machines.

  20. Computational split-field finite-difference time-domain evaluation of simplified tilt-angle models for parallel-aligned liquid-crystal devices

    Science.gov (United States)

    Márquez, Andrés; Francés, Jorge; Martínez, Francisco J.; Gallego, Sergi; Álvarez, Mariela L.; Calzado, Eva M.; Pascual, Inmaculada; Beléndez, Augusto

    2018-03-01

    Simplified analytical models with predictive capability enable simpler and faster optimization of the performance in applications of complex photonic devices. We recently demonstrated the most simplified analytical model still showing predictive capability for parallel-aligned liquid crystal on silicon (PA-LCoS) devices, which provides the voltage-dependent retardance for a very wide range of incidence angles and any wavelength in the visible. We further show that the proposed model is not only phenomenological but also physically meaningful, since two of its parameters provide the correct values for important internal properties of these devices related to the birefringence, cell gap, and director profile. Therefore, the proposed model can be used as a means to inspect internal physical properties of the cell. As an innovation, we also show the applicability of the split-field finite-difference time-domain (SF-FDTD) technique for phase-shift and retardance evaluation of PA-LCoS devices under oblique incidence. As a simplified model for PA-LCoS devices, we also consider the exact description of homogeneous birefringent slabs. However, we show that, despite its higher degree of simplification, the proposed model is more robust, providing unambiguous and physically meaningful solutions when fitting its parameters.

  1. Alignments of galaxies within cosmic filaments from SDSS DR7

    Energy Technology Data Exchange (ETDEWEB)

    Zhang, Youcai; Yang, Xiaohu [Key Laboratory for Research in Galaxies and Cosmology, Shanghai Astronomical Observatory, Nandan Road 80, Shanghai 200030 (China); Wang, Huiyuan [Key Laboratory for Research in Galaxies and Cosmology, University of Science and Technology of China, Hefei, Anhui 230026 (China); Wang, Lei [Purple Mountain Observatory, the Partner Group of MPI für Astronomie, 2 West Beijing Road, Nanjing 210008 (China); Mo, H. J. [Department of Astronomy, University of Massachusetts, Amherst, MA 01003-9305 (United States); Van den Bosch, Frank C., E-mail: yczhang@shao.ac.cn, E-mail: xyang@sjtu.edu.cn [Department of Astronomy, Yale University, P.O. Box 208101, New Haven, CT 06520-8101 (United States)

    2013-12-20

    Using a sample of galaxy groups selected from the Sloan Digital Sky Survey Data Release 7, we examine the alignment between the orientation of galaxies and their surrounding large-scale structure in the context of the cosmic web. The latter is quantified using the large-scale tidal field, reconstructed from the data using galaxy groups above a certain mass threshold. We find that the major axes of galaxies in filaments tend to be preferentially aligned with the directions of the filaments, while galaxies in sheets have their major axes preferentially aligned parallel to the plane of the sheets. The strength of this alignment signal is strongest for red, central galaxies, and in good agreement with that of dark matter halos in N-body simulations. This suggests that red, central galaxies are well aligned with their host halos, in quantitative agreement with previous studies based on the spatial distribution of satellite galaxies. There is a luminosity and mass dependence that brighter and more massive galaxies in filaments and sheets have stronger alignment signals. We also find that the orientation of galaxies is aligned with the eigenvector associated with the smallest eigenvalue of the tidal tensor. These observational results indicate that galaxy formation is affected by large-scale environments and strongly suggest that galaxies are aligned with each other over scales comparable to those of sheets and filaments in the cosmic web.

  2. Alignments of galaxies within cosmic filaments from SDSS DR7

    International Nuclear Information System (INIS)

    Zhang, Youcai; Yang, Xiaohu; Wang, Huiyuan; Wang, Lei; Mo, H. J.; Van den Bosch, Frank C.

    2013-01-01

    Using a sample of galaxy groups selected from the Sloan Digital Sky Survey Data Release 7, we examine the alignment between the orientation of galaxies and their surrounding large-scale structure in the context of the cosmic web. The latter is quantified using the large-scale tidal field, reconstructed from the data using galaxy groups above a certain mass threshold. We find that the major axes of galaxies in filaments tend to be preferentially aligned with the directions of the filaments, while galaxies in sheets have their major axes preferentially aligned parallel to the plane of the sheets. The strength of this alignment signal is strongest for red, central galaxies, and in good agreement with that of dark matter halos in N-body simulations. This suggests that red, central galaxies are well aligned with their host halos, in quantitative agreement with previous studies based on the spatial distribution of satellite galaxies. There is a luminosity and mass dependence that brighter and more massive galaxies in filaments and sheets have stronger alignment signals. We also find that the orientation of galaxies is aligned with the eigenvector associated with the smallest eigenvalue of the tidal tensor. These observational results indicate that galaxy formation is affected by large-scale environments and strongly suggest that galaxies are aligned with each other over scales comparable to those of sheets and filaments in the cosmic web.

  3. Collisionless reconnection: magnetic field line interaction

    Directory of Open Access Journals (Sweden)

    R. A. Treumann

    2012-10-01

    Full Text Available Magnetic field lines are quantum objects carrying one quantum Φ0 = 2πh/e of magnetic flux and have finite radius λm. Here we argue that they possess a very specific dynamical interaction. Parallel field lines reject each other. When confined to a certain area they form two-dimensional lattices of hexagonal structure. We estimate the filling factor of such an area. Anti-parallel field lines, on the other hand, attract each other. We identify the physical mechanism as being due to the action of the gauge potential field, which we determine quantum mechanically for two parallel and two anti-parallel field lines. The distortion of the quantum electrodynamic vacuum causes a cloud of virtual pairs. We calculate the virtual pair production rate from quantum electrodynamics and estimate the virtual pair cloud density, pair current and Lorentz force density acting on the field lines via the pair cloud. These properties of field line dynamics become important in collisionless reconnection, consistently explaining why and how reconnection can spontaneously set on in the field-free centre of a current sheet below the electron-inertial scale.

  4. Parallel Monte Carlo Search for Hough Transform

    Science.gov (United States)

    Lopes, Raul H. C.; Franqueira, Virginia N. L.; Reid, Ivan D.; Hobson, Peter R.

    2017-10-01

    We investigate the problem of line detection in digital image processing and in special how state of the art algorithms behave in the presence of noise and whether CPU efficiency can be improved by the combination of a Monte Carlo Tree Search, hierarchical space decomposition, and parallel computing. The starting point of the investigation is the method introduced in 1962 by Paul Hough for detecting lines in binary images. Extended in the 1970s to the detection of space forms, what came to be known as Hough Transform (HT) has been proposed, for example, in the context of track fitting in the LHC ATLAS and CMS projects. The Hough Transform transfers the problem of line detection, for example, into one of optimization of the peak in a vote counting process for cells which contain the possible points of candidate lines. The detection algorithm can be computationally expensive both in the demands made upon the processor and on memory. Additionally, it can have a reduced effectiveness in detection in the presence of noise. Our first contribution consists in an evaluation of the use of a variation of the Radon Transform as a form of improving theeffectiveness of line detection in the presence of noise. Then, parallel algorithms for variations of the Hough Transform and the Radon Transform for line detection are introduced. An algorithm for Parallel Monte Carlo Search applied to line detection is also introduced. Their algorithmic complexities are discussed. Finally, implementations on multi-GPU and multicore architectures are discussed.

  5. Same-source parallel implementation of the PSU/NCAR MM5

    Energy Technology Data Exchange (ETDEWEB)

    Michalakes, J.

    1997-12-31

    The Pennsylvania State/National Center for Atmospheric Research Mesoscale Model is a limited-area model of atmospheric systems, now in its fifth generation, MM5. Designed and maintained for vector and shared-memory parallel architectures, the official version of MM5 does not run on message-passing distributed memory (DM) parallel computers. The authors describe a same-source parallel implementation of the PSU/NCAR MM5 using FLIC, the Fortran Loop and Index Converter. The resulting source is nearly line-for-line identical with the original source code. The result is an efficient distributed memory parallel option to MM5 that can be seamlessly integrated into the official version.

  6. Field aligned flows driven by neutral puffing at MAST

    Science.gov (United States)

    Waters, I.; Frerichs, H.; Silburn, S.; Feng, Y.; Harrison, J.; Kirk, A.; Schmitz, O.

    2018-06-01

    Neutral deuterium gas puffing at the high field side of the mega ampere spherical tokamak (MAST) is shown to drive carbon impurity flows that are aligned with the trajectory of the magnetic field lines in the plasma scrape-off-layer. These impurity flows were directly imaged with emissions from C2+ ions at MAST by coherence imaging spectroscopy and were qualitatively reproduced in deuterium plasmas by modeling with the EMC3-EIRENE plasma edge fluid and kinetic neutral transport code. A reduced one-dimensional momentum and particle balance shows that a localized increase in the static plasma pressure in front of the neutral gas puff yields an acceleration of the plasma due to local ionization. Perpendicular particle transport yields a decay from which a parallel length scale can be determined. Parameter scans in EMC3-EIRENE were carried out to determine the sensitivity of the deuterium plasma flow phenomena to local fueling and diffusion parameters and it is found that these flows robustly form across a wide variety of plasma conditions. Finally, efforts to couple this behavior in the background plasma directly to the impurity flows observed experimentally in MAST using a trace impurity model are discussed. These results provide insight into the fueling and exhaust features at this pivotal point of the radial and parallel particle flux balance, which is a major part of the plasma fueling and exhaust characteristics in a magnetically confined fusion device.

  7. Micromachined silicon parallel acoustic delay lines as time-delayed ultrasound detector array for real-time photoacoustic tomography

    Science.gov (United States)

    Cho, Y.; Chang, C.-C.; Wang, L. V.; Zou, J.

    2016-02-01

    This paper reports the development of a new 16-channel parallel acoustic delay line (PADL) array for real-time photoacoustic tomography (PAT). The PADLs were directly fabricated from single-crystalline silicon substrates using deep reactive ion etching. Compared with other acoustic delay lines (e.g., optical fibers), the micromachined silicon PADLs offer higher acoustic transmission efficiency, smaller form factor, easier assembly, and mass production capability. To demonstrate its real-time photoacoustic imaging capability, the silicon PADL array was interfaced with one single-element ultrasonic transducer followed by one channel of data acquisition electronics to receive 16 channels of photoacoustic signals simultaneously. A PAT image of an optically-absorbing target embedded in an optically-scattering phantom was reconstructed, which matched well with the actual size of the imaged target. Because the silicon PADL array allows a signal-to-channel reduction ratio of 16:1, it could significantly simplify the design and construction of ultrasonic receivers for real-time PAT.

  8. Micromachined silicon parallel acoustic delay lines as time-delayed ultrasound detector array for real-time photoacoustic tomography

    International Nuclear Information System (INIS)

    Cho, Y; Chang, C-C; Zou, J; Wang, L V

    2016-01-01

    This paper reports the development of a new 16-channel parallel acoustic delay line (PADL) array for real-time photoacoustic tomography (PAT). The PADLs were directly fabricated from single-crystalline silicon substrates using deep reactive ion etching. Compared with other acoustic delay lines (e.g., optical fibers), the micromachined silicon PADLs offer higher acoustic transmission efficiency, smaller form factor, easier assembly, and mass production capability. To demonstrate its real-time photoacoustic imaging capability, the silicon PADL array was interfaced with one single-element ultrasonic transducer followed by one channel of data acquisition electronics to receive 16 channels of photoacoustic signals simultaneously. A PAT image of an optically-absorbing target embedded in an optically-scattering phantom was reconstructed, which matched well with the actual size of the imaged target. Because the silicon PADL array allows a signal-to-channel reduction ratio of 16:1, it could significantly simplify the design and construction of ultrasonic receivers for real-time PAT. (paper)

  9. Automatic Loop Parallelization via Compiler Guided Refactoring

    DEFF Research Database (Denmark)

    Larsen, Per; Ladelsky, Razya; Lidman, Jacob

    For many parallel applications, performance relies not on instruction-level parallelism, but on loop-level parallelism. Unfortunately, many modern applications are written in ways that obstruct automatic loop parallelization. Since we cannot identify sufficient parallelization opportunities...... for these codes in a static, off-line compiler, we developed an interactive compilation feedback system that guides the programmer in iteratively modifying application source, thereby improving the compiler’s ability to generate loop-parallel code. We use this compilation system to modify two sequential...... benchmarks, finding that the code parallelized in this way runs up to 8.3 times faster on an octo-core Intel Xeon 5570 system and up to 12.5 times faster on a quad-core IBM POWER6 system. Benchmark performance varies significantly between the systems. This suggests that semi-automatic parallelization should...

  10. Anisotropic hypersonic phonon propagation in films of aligned ellipsoids.

    Science.gov (United States)

    Beltramo, Peter J; Schneider, Dirk; Fytas, George; Furst, Eric M

    2014-11-14

    A material with anisotropic elastic mechanical properties and a direction-dependent hypersonic band gap is fabricated using ac electric field-directed convective self-assembly of colloidal ellipsoids. The frequency of the gap, which is detected in the direction perpendicular to particle alignment and entirely absent parallel to alignment, and the effective sound velocities can be tuned by the particle aspect ratio. We hypothesize that the band gap originates from the primary eigenmode peak, the m-splitted (s,1,2) mode, of the particle resonating with the effective medium. These results reveal the potential for powerful control of the hypersonic phononic band diagram by combining anisotropic particles and self-assembly.

  11. Parallel graded attention in reading: A pupillometric study

    NARCIS (Netherlands)

    Snell, Joshua; Mathot, Sebastiaan; Mirault, Jonathan; Grainger, Jonathan

    2018-01-01

    There are roughly two lines of theory to account for recent evidence that word processing is influenced by adjacent orthographic information. One line assumes that multiple words can be processed simultaneously through a parallel graded distribution of visuo-spatial attention. The other line assumes

  12. NIF pointing and centering systems and target alignment using a 351 nm laser source

    International Nuclear Information System (INIS)

    Boege, S.J.; Bliss, E.S.; Chocol, C.J.; Holdener, F.R.; Miller, J.L.; Toeppen, J.S.; Vann, C.S.; Zacharias, R.A.

    1996-10-01

    The operational requirements of the National Ignition Facility (NIF) place tight constraints upon its alignment system. In general, the alignment system must establish and maintain the correct relationships between beam position, beam angle, laser component clear apertures, and the target. At the target, this includes adjustment of beam focus to obtain the correct spot size. This must be accomplished for all beamlines in a time consistent with planned shot rates and yet, in the front end and main laser, beam control functions cannot be initiated until the amplifiers have sufficiently cooled so as to minimize dynamic thermal distortions during and after alignment and wavefront optimization. The scope of the task dictates an automated system that implements parallel processes. We describe reticle choices and other alignment references, insertion of alignment beams, principles of operation of the Chamber Center Reference System 2048 and Target Alignment Sensor, and the anticipated alignment sequence that will occur between shots

  13. Alignment of the diamond nitrogen vacancy center by strain engineering

    Energy Technology Data Exchange (ETDEWEB)

    Karin, Todd [Department of Physics, University of Washington, Seattle, Washington 98195 (United States); Dunham, Scott [Department of Electrical Engineering, University of Washington, Seattle, Washington 98195 (United States); Fu, Kai-Mei [Department of Physics, University of Washington, Seattle, Washington 98195 (United States); Department of Electrical Engineering, University of Washington, Seattle, Washington 98195 (United States)

    2014-08-04

    The nitrogen vacancy (NV) center in diamond is a sensitive probe of magnetic field and a promising qubit candidate for quantum information processing. The performance of many NV-based devices improves by aligning the NV(s) parallel to a single crystallographic direction. Using ab initio theoretical techniques, we show that NV orientation can be controlled by high-temperature annealing in the presence of strain under currently accessible experimental conditions. We find that (89 ± 7)% of NVs align along the [111] crystallographic direction under 2% compressive biaxial strain (perpendicular to [111]) and an annealing temperature of 970 °C.

  14. Monitoring of absolute mirror alignment at COMPASS RICH-1 detector

    NARCIS (Netherlands)

    Alexeev, M.; Birsa, R.; Bradamante, F.; Bressan, A.; Chiosso, M.; Ciliberti, P.; Dalla Torre, S.; Denisov, O.; Duic, V.; Ferrero, A.; Finger, M.; Finger, M.; Gayde, J. Ch; Giorgi, M.; Gobbo, B.; Levorato, S.; Maggiora, A.; Martin, A.; Menon, G.; Panzieri, D.; Pesaro, G.; Polak, J.; Rocco, E.; Sbrizzai, G.; Schiavon, P.; Slunecka, M.; Sozzi, F.; Steiger, L.; Sulc, M.; Takekawa, S.; Tessarotto, F.

    2014-01-01

    The gaseous COMPASS RICH-1 detector uses two spherical mirror surfaces, segmented into 116 individual mirrors, to focus the Cherenkov photons onto the detector plane. Any mirror misalignment directly affects the detector resolution. The on-line Continuous Line Alignment and Monitoring (CLAM)

  15. Design of a magnetic field alignment diagnostic for the MFTF-B magnet system

    International Nuclear Information System (INIS)

    Deadrick, F.J.; House, P.A.; Frye, R.W.

    1985-01-01

    Magnet alignment in tandem mirror fusion machines plays a crucial role in achieving and maintaining plasma confinement. Various visual alignment tools have been described by Post et al. to align the Tara magnet system. We have designed and installed a remotely operated magnetic field alignment (MFA) diagnostic system as a part of the Mirror Fusion Test Facility (MFTF-B). It measures critical magnetic field alignment parameters of the MFTF-B coil set while under full-field operating conditions. The MFA diagnostic employs a pair of low-energy, electron beam guns on a remotely positionable probe to trace and map selected magnetic field lines. An array of precision electrical detector paddles locates the position of the electron beam, and thus the magnetic field line, at several critical points. The measurements provide a means to compute proper compensating currents to correct for mechanical misalignments of the magnets with auxiliary trim coils if necessary. This paper describes both the mechanical and electrical design of the MFA diagnostic hardware

  16. Conformal pure radiation with parallel rays

    International Nuclear Information System (INIS)

    Leistner, Thomas; Paweł Nurowski

    2012-01-01

    We define pure radiation metrics with parallel rays to be n-dimensional pseudo-Riemannian metrics that admit a parallel null line bundle K and whose Ricci tensor vanishes on vectors that are orthogonal to K. We give necessary conditions in terms of the Weyl, Cotton and Bach tensors for a pseudo-Riemannian metric to be conformal to a pure radiation metric with parallel rays. Then, we derive conditions in terms of the tractor calculus that are equivalent to the existence of a pure radiation metric with parallel rays in a conformal class. We also give analogous results for n-dimensional pseudo-Riemannian pp-waves. (paper)

  17. Evidence for Field-parallel Electron Acceleration in Solar Flares

    Energy Technology Data Exchange (ETDEWEB)

    Haerendel, G. [Max Planck Institute for Extraterrestrial Physics, Garching (Germany)

    2017-10-01

    It is proposed that the coincidence of higher brightness and upward electric current observed by Janvier et al. during a flare indicates electron acceleration by field-parallel potential drops sustained by extremely strong field-aligned currents of the order of 10{sup 4} A m{sup −2}. A consequence of this is the concentration of the currents in sheets with widths of the order of 1 m. The high current density suggests that the field-parallel potential drops are maintained by current-driven anomalous resistivity. The origin of these currents remains a strong challenge for theorists.

  18. Intradomain Textures in Block Copolymers: Multizone Alignment and Biaxiality

    Science.gov (United States)

    Prasad, Ishan; Seo, Youngmi; Hall, Lisa M.; Grason, Gregory M.

    2017-06-01

    Block copolymer (BCP) melt assembly has been studied for decades, focusing largely on self-organized spatial patterns of periodically ordered segment density. Here, we demonstrate that underlying the well-known composition profiles (i.e., ordered lamella, cylinders, spheres, and networks) are generic and heterogeneous patterns of segment orientation that couple strongly to morphology, even in the absence of specific factors that promote intra or interchain segment alignment. We employ both self-consistent field theory and coarse-grained simulation methods to measure polar and nematic order parameters of segments in a freely jointed chain model of diblock melts. We show that BCP morphologies have a multizone texture, with segments predominantly aligned normal and parallel to interdomain interfaces in the respective brush and interfacial regions of the microdomain. Further, morphologies with anisotropically curved interfaces (i.e., cylinders and networks) exhibit biaxial order that is aligned to the principal curvature axes of the interface.

  19. MUMmer4: A fast and versatile genome alignment system.

    Directory of Open Access Journals (Sweden)

    Guillaume Marçais

    2018-01-01

    Full Text Available The MUMmer system and the genome sequence aligner nucmer included within it are among the most widely used alignment packages in genomics. Since the last major release of MUMmer version 3 in 2004, it has been applied to many types of problems including aligning whole genome sequences, aligning reads to a reference genome, and comparing different assemblies of the same genome. Despite its broad utility, MUMmer3 has limitations that can make it difficult to use for large genomes and for the very large sequence data sets that are common today. In this paper we describe MUMmer4, a substantially improved version of MUMmer that addresses genome size constraints by changing the 32-bit suffix tree data structure at the core of MUMmer to a 48-bit suffix array, and that offers improved speed through parallel processing of input query sequences. With a theoretical limit on the input size of 141Tbp, MUMmer4 can now work with input sequences of any biologically realistic length. We show that as a result of these enhancements, the nucmer program in MUMmer4 is easily able to handle alignments of large genomes; we illustrate this with an alignment of the human and chimpanzee genomes, which allows us to compute that the two species are 98% identical across 96% of their length. With the enhancements described here, MUMmer4 can also be used to efficiently align reads to reference genomes, although it is less sensitive and accurate than the dedicated read aligners. The nucmer aligner in MUMmer4 can now be called from scripting languages such as Perl, Python and Ruby. These improvements make MUMer4 one the most versatile genome alignment packages available.

  20. Strain-induced alignment and phase behavior of blue phase liquid crystals confined to thin films.

    Science.gov (United States)

    Bukusoglu, Emre; Martinez-Gonzalez, Jose A; Wang, Xiaoguang; Zhou, Ye; de Pablo, Juan J; Abbott, Nicholas L

    2017-12-06

    We report on the influence of surface confinement on the phase behavior and strain-induced alignment of thin films of blue phase liquid crystals (BPs). Confining surfaces comprised of bare glass, dimethyloctadecyl [3-(trimethoxysilyl)propyl] ammonium chloride (DMOAP)-functionalized glass, or polyvinyl alcohol (PVA)-coated glass were used with or without mechanically rubbing to influence the azimuthal anchoring of the BPs. These experiments reveal that confinement can change the phase behavior of the BP films. For example, in experiments performed with rubbed-PVA surfaces, we measured the elastic strain of the BPs to change the isotropic-BPII phase boundary, suppressing formation of BPII for film thicknesses incommensurate with the BPII lattice. In addition, we observed strain-induced alignment of the BPs to exhibit a complex dependence on both the surface chemistry and azimuthal alignment of the BPs. For example, when using bare glass surfaces causing azimuthally degenerate and planar anchoring, BPI oriented with (110) planes of the unit cell parallel to the contacting surfaces for thicknesses below 3 μm but transitioned to an orientation with (200) planes aligned parallel to the contacting surfaces for thicknesses above 4 μm. In contrast, BPI aligned with (110) planes parallel to confining surfaces for all other thicknesses and surface treatments, including bare glass with uniform azimuthal alignment. Complementary simulations based on minimization of the total free energy (Landau-de Gennes formalism) confirmed a thickness-dependent reorientation due to strain of BPI unit cells within a window of surface anchoring energies and in the absence of uniform azimuthal alignment. In contrast to BPI, BPII did not exhibit thickness-dependent orientations but did exhibit orientations that were dependent on the surface chemistry, a result that was also captured in simulations by varying the anchoring energies. Overall, the results in this paper reveal that the orientations

  1. Scattering of field-aligned beam ions upstream of Earth's bow shock

    Directory of Open Access Journals (Sweden)

    A. Kis

    2007-03-01

    Full Text Available Field-aligned beams are known to originate from the quasi-perpendicular side of the Earth's bow shock, while the diffuse ion population consists of accelerated ions at the quasi-parallel side of the bow shock. The two distinct ion populations show typical characteristics in their velocity space distributions. By using particle and magnetic field measurements from one Cluster spacecraft we present a case study when the two ion populations are observed simultaneously in the foreshock region during a high Mach number, high solar wind velocity event. We present the spatial-temporal evolution of the field-aligned beam ion distribution in front of the Earth's bow shock, focusing on the processes in the deep foreshock region, i.e. on the quasi-parallel side. Our analysis demonstrates that the scattering of field-aligned beam (FAB ions combined with convection by the solar wind results in the presence of lower-energy, toroidal gyrating ions at positions deeper in the foreshock region which are magnetically connected to the quasi-parallel bow shock. The gyrating ions are superposed onto a higher energy diffuse ion population. It is suggested that the toroidal gyrating ion population observed deep in the foreshock region has its origins in the FAB and that its characteristics are correlated with its distance from the FAB, but is independent on distance to the bow shock along the magnetic field.

  2. Digital parallel-to-series pulse-train converter

    Science.gov (United States)

    Hussey, J.

    1971-01-01

    Circuit converts number represented as two level signal on n-bit lines to series of pulses on one of two lines, depending on sign of number. Converter accepts parallel binary input data and produces number of output pulses equal to number represented by input data.

  3. Microfabrication of pre-aligned fiber bundle couplers using ultraviolet lithography of SU-8

    OpenAIRE

    Yang, Ren; Soper, Steven A.; Wang, Wanjun

    2006-01-01

    This paper describes the design, microfabrication and testing of a pre-aligned array of fiber couplers using direct UV-lithography of SU-8. The fiber coupler array includes an out-of-plane refractive microlens array and two fiberport collimator arrays. With the optical axis of the pixels parallel to the substrate, each pixel of the microlens array can be pre-aligned with the corresponding pixels of the fiberport collimator array as defined by the lithography mask design. This out-of-plane pol...

  4. Uniaxially aligned ceramic nanofibers obtained by chemical mechanical processing

    Energy Technology Data Exchange (ETDEWEB)

    Tararam, R. [Univ Estadual Paulista – UNESP – Instituto de Química, Rua Prof. Francisco Degni n° 55, CEP 14800-900 Araraquara, SP (Brazil); Foschini, C.R. [Univ Estadual Paulista – UNESP – Faculdade de Engenharia de Bauru, Dept. de Eng. Mecanica, Av. Eng. Luiz Edmundo C. Coube 14-01, CEP 17033-360 Bauru, SP (Brazil); Destro, F.B. [Univ Estadual Paulista – UNESP – Faculdade de Engenharia de Guaratinguetá, Guaratinguetá 12516-410, SP (Brazil); Simões, A.Z., E-mail: alezipo@yahoo.com [Univ Estadual Paulista – UNESP – Faculdade de Engenharia de Guaratinguetá, Guaratinguetá 12516-410, SP (Brazil); Longo, E.; Varela, J.A. [Univ Estadual Paulista – UNESP – Instituto de Química, Rua Prof. Francisco Degni n° 55, CEP 14800-900 Araraquara, SP (Brazil)

    2014-08-01

    For this study, we investigated a simple method to generate well aligned nanofibers over large areas using an organic polymer stretched over the substrate surface With this method, ZnO and CuO 3D parallel nanowire arrays were successfully prepared by calcinations of the polymer fibers. X-ray diffraction (XRD) analysis revealed that the copper oxide has a monoclinic structure while the zinc oxide has a hexagonal structure. Scanning electron microscopy (SEM) analysis showed ceramic nanofibers with an average diameter of 120 nm which were composed of small nanoparticles which are 10 nm in diameter. The ability to obtain uniaxially aligned nanofibers reveals a range of interesting properties with potential applications for sensors, catalysts and energy technologies.

  5. Amplitude differences least squares method applied to temporal cardiac beat alignment

    International Nuclear Information System (INIS)

    Correa, R O; Laciar, E; Valentinuzzi, M E

    2007-01-01

    High resolution averaged ECG is an important diagnostic technique in post-infarcted and/or chagasic patients with high risk of ventricular tachycardia (VT). It calls for precise determination of the synchronism point (fiducial point) in each beat to be averaged. Cross-correlation (CC) between each detected beat and a reference beat is, by and large, the standard alignment procedure. However, the fiducial point determination is not precise in records contaminated with high levels of noise. Herein, we propose an alignment procedure based on the least squares calculation of the amplitude differences (LSAD) between the ECG samples and a reference or template beat. Both techniques, CC and LSAD, were tested in high resolution ECG's corrupted with white noise and 50 Hz line interference of varying amplitudes (RMS range: 0-100μV). Results point out that LSDA produced a lower alignment error in all contaminated records while in those blurred by power line interference better results were found only within the 0-40 μV range. It is concluded that the proposed method represents a valid alignment alternative

  6. Collimated-hole structures as efficient differential pumping barrier, one-way valve and tool for aligning Penning traps

    International Nuclear Information System (INIS)

    Kluge, H.-Jürgen; Block, Michael; Herfurth, Frank

    2011-01-01

    A collimated-hole structure consists of a very large number of parallel channels which have each a very small diameter and are closely packed together. Such devices, installed in vacuum systems allow one to separate regions of very different gas pressures. A collimated-hole structure has high transmission for a directed ion beam with low emittance but a very low conductance for rest gas atoms or molecules exhibiting random walk. Therefore it is proposed to use such a structure as one-way valve and/or efficient differential pumping barrier in set-ups using Penning traps. Furthermore, these devices might be very useful to align the axis of a Penning trap with the direction of the magnetic field lines which is essential to avoid systematic uncertainties in high-accuracy mass spectroscopy.

  7. High-spin states beyond the proton drip-line: Quasiparticle alignments in {sup 113}Cs

    Energy Technology Data Exchange (ETDEWEB)

    Wady, P.T. [School of Engineering, University of the West of Scotland, Paisley, PA1 2BE (United Kingdom); Scottish Universities Physics Alliance (United Kingdom); Smith, J.F., E-mail: John.F.Smith@uws.ac.uk [School of Engineering, University of the West of Scotland, Paisley, PA1 2BE (United Kingdom); Scottish Universities Physics Alliance (United Kingdom); Hadinia, B. [School of Engineering, University of the West of Scotland, Paisley, PA1 2BE (United Kingdom); Scottish Universities Physics Alliance (United Kingdom); Cullen, D.M.; Freeman, S.J. [School of Physics and Astronomy, University of Manchester, Manchester, M13 9PL (United Kingdom); Darby, I.G. [Department of Physics, Oliver Lodge Laboratory, University of Liverpool, Liverpool, L69 7ZE (United Kingdom); Eeckhaudt, S.; Grahn, T.; Greenlees, P.T.; Jones, P.M.; Julin, R.; Juutinen, S.; Kettunen, H.; Leino, M.; Leppänen, A.-P. [Department of Physics, University of Jyväskylä, FIN-40014, Jyväskylä (Finland); McGuirk, B.M. [Department of Physics, Oliver Lodge Laboratory, University of Liverpool, Liverpool, L69 7ZE (United Kingdom); Nieminen, P.; Nyman, M. [Department of Physics, University of Jyväskylä, FIN-40014, Jyväskylä (Finland); Page, R.D. [Department of Physics, Oliver Lodge Laboratory, University of Liverpool, Liverpool, L69 7ZE (United Kingdom); Pakarinen, J. [Department of Physics, University of Jyväskylä, FIN-40014, Jyväskylä (Finland); and others

    2015-01-05

    Excited states have been studied in the deformed proton emitter {sup 113}Cs. Gamma-ray transitions have been unambiguously assigned to {sup 113}Cs by correlation with its characteristic proton decay, using the method of recoil-decay tagging. Two previously identified rotational bands have been observed and extended to tentative spins of 45/2 and 51/2ħ, with excitation energies over 8 MeV above the lowest state. These are the highest angular momenta and excitation energies observed to date in any nucleus beyond the proton drip-line. Transitions in the bands have been rearranged compared to previous work. A study of aligned angular momenta, in comparison to the predictions of Woods–Saxon cranking calculations, is consistent with the most intense band being based on the πg{sub 7/2}[422]3/2{sup +} configuration, which would contradict the earlier πh{sub 11/2} assignment, and with the second band being based on the πd{sub 5/2}[420]1/2{sup +} configuration. The data suggest that the band based upon the πh{sub 11/2} configuration is not observed.

  8. 2 GHz self-aligning tandem A/D converter for SAR

    DEFF Research Database (Denmark)

    Søbjærg, Sten Schmidl; Christensen, Erik Lintz

    2001-01-01

    digitizing, and the other is to digitize the signal before digital I/Q demodulation. In both cases the digitizing may be performed by a digital front end (DFE) with two parallel analog-to-digital-converters (ADCs) sampling at 1 GHz in phase or in anti-phase respectively, provided the analog bandwidth...... of the ADC is sufficient. In the first case each ADC has to digitize a 0-400 MHz signal, and in the second case both ADCs have to digitize a 100-900 MHz signal. In both cases the sampling time alignment is a critical parameter. The paper addresses some aspects of ADC alignment in the implementation of a DFE...

  9. Regionally Aligned Divisions: Enabling Cultural and Linguistic Competency in Regionally Aligned Forces

    Science.gov (United States)

    2016-05-26

    HQDA) Regionally Aligned Forces (RAF) EXORD, 56. 8 George Siemens, “Connectivism: A Learning Theory for the Digital Age,” International Journal of...J. Clauzel, “Évolution de la vie économique et des structures sociales du pays nomade du Malil: De la conquête française à l’autonomie interne 1893...121 Donald E. Vandergriff, Digital War: A View from the Front Line, ed. Robert L. Bateman (Novato: Presidio Press, 1999). 122 Douglas M. Chalmers

  10. Progress in ETA-II magnetic field alignment using stretched wire and low energy electron beam techniques

    International Nuclear Information System (INIS)

    Griffith, L.V.; Deadrick, F.J.

    1991-01-01

    Flux line alignment of the solenoidal focus magnets used on the ETA-II linear induction accelerator is a key element leading to a reduction of beam corkscrew motion. Two techniques have been used on the ETA-II accelerator to measure and establish magnet alignment. A low energy electron beam has been used to directly map magnetic field lines, and recent work has utilized a pulsed stretched wire technique to measure magnet tilts and offsets with respect to a reference axis. This paper reports on the techniques used in the ETA-II accelerator alignment, and presents results from those measurements which show that accelerator is magnetically aligned to within ∼ ± 200 microns

  11. Design and fabrication of a self-aligned parallel-plate-type silicon micromirror minimizing the effect of misalignment

    International Nuclear Information System (INIS)

    Yoo, Byung-Wook; Jin, Joo-Young; Jang, Yun-Ho; Kim, Yong-Kweon; Park, Jae-Hyoung

    2009-01-01

    This paper describes a self-alignment method whereby a mirror actuation voltage, corresponding to a specific tilting angle, is unvarying in terms of misalignment during fabrication. A deep silicon etching process is proposed to penetrate the top silicon layer (the micromirror layer) and an amorphous silicon layer (the addressing electrode layer) together, through an aluminum mask pattern, in order to minimize the misalignment effect on the micromirror actuation. The size of a fabricated mirror plate is 250 × 250 × 4 µm 3 . A pair of amorphous silicon electrodes under the mirror plate is about half the size of the mirror plate individually. Numerical analysis associated with calculating the pull-in voltage and the bonding misalignment is performed to verify the self-alignment concepts focused upon in this paper. Curves of the applied voltage versus the tilt angle of the self-aligned micromirror are observed using a position sensing detector in order to compare the measurement results with MATLAB analysis of the expected static deflections. Although a 3.7 µm misalignment is found between the mirror plate and the electrodes, in the direction perpendicular to the shallow trench of the electrodes, before the self-alignment process, the measured pull-in voltage has been found to be 103.4 V on average; this differs from the pull-in voltage of a perfectly aligned micromirror by only 0.67%. Regardless of the unpredictable misalignments in repetitive photolithography and bonding, the tilting angles corresponding to the driving voltages are proved to be uniform along the single axis as well as conform to the results of analytical analysis

  12. Elevation angle alignment of quasi optical receiver mirrors of collective Thomson scattering diagnostic by sawtooth measurements

    DEFF Research Database (Denmark)

    Moseev, D.; Meo, Fernando; Korsholm, Søren Bang

    2012-01-01

    require a good alignment of the optical path in the transmission line. Monitoring the alignment during the experiment greatly benefits the confidence in the CTS measurements. An in situ technique for the assessment of the elevation angle alignment of the receiver is developed. Using the CTS diagnostic...

  13. From Word Alignment to Word Senses, via Multilingual Wordnets

    Directory of Open Access Journals (Sweden)

    Dan Tufis

    2006-05-01

    Full Text Available Most of the successful commercial applications in language processing (text and/or speech dispense with any explicit concern on semantics, with the usual motivations stemming from the computational high costs required for dealing with semantics, in case of large volumes of data. With recent advances in corpus linguistics and statistical-based methods in NLP, revealing useful semantic features of linguistic data is becoming cheaper and cheaper and the accuracy of this process is steadily improving. Lately, there seems to be a growing acceptance of the idea that multilingual lexical ontologisms might be the key towards aligning different views on the semantic atomic units to be used in characterizing the general meaning of various and multilingual documents. Depending on the granularity at which semantic distinctions are necessary, the accuracy of the basic semantic processing (such as word sense disambiguation can be very high with relatively low complexity computing. The paper substantiates this statement by presenting a statistical/based system for word alignment and word sense disambiguation in parallel corpora. We describe a word alignment platform which ensures text pre-processing (tokenization, POS-tagging, lemmatization, chunking, sentence and word alignment as required by an accurate word sense disambiguation.

  14. ClustalXeed: a GUI-based grid computation version for high performance and terabyte size multiple sequence alignment

    Directory of Open Access Journals (Sweden)

    Kim Taeho

    2010-09-01

    Full Text Available Abstract Background There is an increasing demand to assemble and align large-scale biological sequence data sets. The commonly used multiple sequence alignment programs are still limited in their ability to handle very large amounts of sequences because the system lacks a scalable high-performance computing (HPC environment with a greatly extended data storage capacity. Results We designed ClustalXeed, a software system for multiple sequence alignment with incremental improvements over previous versions of the ClustalX and ClustalW-MPI software. The primary advantage of ClustalXeed over other multiple sequence alignment software is its ability to align a large family of protein or nucleic acid sequences. To solve the conventional memory-dependency problem, ClustalXeed uses both physical random access memory (RAM and a distributed file-allocation system for distance matrix construction and pair-align computation. The computation efficiency of disk-storage system was markedly improved by implementing an efficient load-balancing algorithm, called "idle node-seeking task algorithm" (INSTA. The new editing option and the graphical user interface (GUI provide ready access to a parallel-computing environment for users who seek fast and easy alignment of large DNA and protein sequence sets. Conclusions ClustalXeed can now compute a large volume of biological sequence data sets, which were not tractable in any other parallel or single MSA program. The main developments include: 1 the ability to tackle larger sequence alignment problems than possible with previous systems through markedly improved storage-handling capabilities. 2 Implementing an efficient task load-balancing algorithm, INSTA, which improves overall processing times for multiple sequence alignment with input sequences of non-uniform length. 3 Support for both single PC and distributed cluster systems.

  15. Angle alignment evokes perceived depth and illusory surfaces.

    Science.gov (United States)

    Shapley, Robert; Maertens, Marianne

    2008-01-01

    There is a distinct visual process that triggers the perception of illusory surfaces and contours along the intersections of aligned, zigzag line patterns. Such illusory contours and surfaces are qualitatively different from illusory contours of the Kanizsa type. The illusory contours and surfaces in this case are not the product of occlusion and do not imply occlusion of one surface by another. Rather, the aligned angles in the patterns are combined by the visual system into the perception of a fold or a 3-D corner, as of stairs on a staircase or a wall ending on a floor. The depth impression is ambiguous and reversible like the Necker cube. Such patterns were used by American Indian artists of the Akimel O'odham (Pima) tribe in basketry, and also by modern European and American artists like Josef Albers, Bridget Riley, Victor Vasarely, and Frank Stella. Our research aims to find out what manipulations of the visual image affect perceived depth in such patterns in order to learn about the perceptual mechanisms. Using paired comparisons, we find that human observers perceive depth in such patterns if, and only if, lines in adjacent regions of the patterns join to form angles, and also if, and only if, the angles are aligned precisely to be consistent with a fold or 3-D corner. The amount of perceived depth is graded, depending on the steepness and the density of angles in the aligned-angle pattern. The required precision of the alignment implies that early retinotopic visual cortical areas may be involved in this perceptual behavior, but the linkage of form with perceived depth suggests involvement of higher cortical areas as well.

  16. SDT: a virus classification tool based on pairwise sequence alignment and identity calculation.

    Directory of Open Access Journals (Sweden)

    Brejnev Muhizi Muhire

    Full Text Available The perpetually increasing rate at which viral full-genome sequences are being determined is creating a pressing demand for computational tools that will aid the objective classification of these genome sequences. Taxonomic classification approaches that are based on pairwise genetic identity measures are potentially highly automatable and are progressively gaining favour with the International Committee on Taxonomy of Viruses (ICTV. There are, however, various issues with the calculation of such measures that could potentially undermine the accuracy and consistency with which they can be applied to virus classification. Firstly, pairwise sequence identities computed based on multiple sequence alignments rather than on multiple independent pairwise alignments can lead to the deflation of identity scores with increasing dataset sizes. Also, when gap-characters need to be introduced during sequence alignments to account for insertions and deletions, methodological variations in the way that these characters are introduced and handled during pairwise genetic identity calculations can cause high degrees of inconsistency in the way that different methods classify the same sets of sequences. Here we present Sequence Demarcation Tool (SDT, a free user-friendly computer program that aims to provide a robust and highly reproducible means of objectively using pairwise genetic identity calculations to classify any set of nucleotide or amino acid sequences. SDT can produce publication quality pairwise identity plots and colour-coded distance matrices to further aid the classification of sequences according to ICTV approved taxonomic demarcation criteria. Besides a graphical interface version of the program for Windows computers, command-line versions of the program are available for a variety of different operating systems (including a parallel version for cluster computing platforms.

  17. Understanding Interfacial Alignment in Solution Coated Conjugated Polymer Thin Films

    International Nuclear Information System (INIS)

    Qu, Ge; Zhao, Xikang; Newbloom, Gregory M.; Zhang, Fengjiao; Mohammadi, Erfan

    2017-01-01

    Domain alignment in conjugated polymer thin films can significantly enhance charge carrier mobility. However, the alignment mechanism during meniscus-guided solution coating remains unclear. Furthermore, interfacial alignment has been rarely studied despite its direct relevance and critical importance to charge transport. In this study, we uncover a significantly higher degree of alignment at the top interface of solution coated thin films, using a donor–acceptor conjugated polymer, poly(diketopyrrolopyrrole-co-thiopheneco- thieno[3,2-b]thiophene-co-thiophene) (DPP2T-TT), as the model system. At the molecular level, we observe in-plane π–π stacking anisotropy of up to 4.8 near the top interface with the polymer backbone aligned parallel to the coating direction. The bulk of the film is only weakly aligned with the backbone oriented transverse to coating. At the mesoscale, we observe a well-defined fibril-like morphology at the top interface with the fibril long axis pointing toward the coating direction. Significantly smaller fibrils with poor orientational order are found on the bottom interface, weakly aligned orthogonal to the fibrils on the top interface. The high degree of alignment at the top interface leads to a charge transport anisotropy of up to 5.4 compared to an anisotropy close to 1 on the bottom interface. We attribute the formation of distinct interfacial morphology to the skin-layer formation associated with high Peclet number, which promotes crystallization on the top interface while suppressing it in the bulk. As a result, we further infer that the interfacial fibril alignment is driven by the extensional flow on the top interface arisen from increasing solvent evaporation rate closer to the meniscus front.

  18. Image stack alignment in full-field X-ray absorption spectroscopy using SIFT_PyOCL.

    Science.gov (United States)

    Paleo, Pierre; Pouyet, Emeline; Kieffer, Jérôme

    2014-03-01

    Full-field X-ray absorption spectroscopy experiments allow the acquisition of millions of spectra within minutes. However, the construction of the hyperspectral image requires an image alignment procedure with sub-pixel precision. While the image correlation algorithm has originally been used for image re-alignment using translations, the Scale Invariant Feature Transform (SIFT) algorithm (which is by design robust versus rotation, illumination change, translation and scaling) presents an additional advantage: the alignment can be limited to a region of interest of any arbitrary shape. In this context, a Python module, named SIFT_PyOCL, has been developed. It implements a parallel version of the SIFT algorithm in OpenCL, providing high-speed image registration and alignment both on processors and graphics cards. The performance of the algorithm allows online processing of large datasets.

  19. High-speed all-optical DNA local sequence alignment based on a three-dimensional artificial neural network.

    Science.gov (United States)

    Maleki, Ehsan; Babashah, Hossein; Koohi, Somayyeh; Kavehvash, Zahra

    2017-07-01

    This paper presents an optical processing approach for exploring a large number of genome sequences. Specifically, we propose an optical correlator for global alignment and an extended moiré matching technique for local analysis of spatially coded DNA, whose output is fed to a novel three-dimensional artificial neural network for local DNA alignment. All-optical implementation of the proposed 3D artificial neural network is developed and its accuracy is verified in Zemax. Thanks to its parallel processing capability, the proposed structure performs local alignment of 4 million sequences of 150 base pairs in a few seconds, which is much faster than its electrical counterparts, such as the basic local alignment search tool.

  20. Alignment in double capture processes

    International Nuclear Information System (INIS)

    Moretto-Capelle, P.; Benhenni, M.; Bordenave-Montesquieu, A.; Benoit-Cattin, P.; Gleizes, A.

    1993-01-01

    The electron spectra emitted when a double capture occurs in N 7+ +He and Ne 8+ +He systems at 10 qkeV collisional energy, allow us to determine the angular distributions of the 3 ell 3 ell ' lines through a special spectra fitting procedure which includes interferences between neighbouring states. It is found that the doubly excited states populated in double capture processes are generally aligned

  1. Short-term magnetic field alignment variations of equatorial ionospheric irregularities

    International Nuclear Information System (INIS)

    Johnson, A.L.

    1988-01-01

    The ionospheric irregularities that cause equatorial scintillation are elongated along the north-south magnetic field lines. During a 1981 field campaign at Ascension Island, 250-MHz receivers were spaced from 300 m to 1.6 km along the field lines, and the signals received from the Marisat satellite were cross correlated. Data collected during eight nights of fading showed a linear relationship between fading rate and cross correlation. The alignment of the antennas was adjusted to give a zero time lag between the widely spaced receivers with a measurement accuracy of 0.03 s. Since the average irregularity velocity was 125 m/s, this time accuracy translated to an angular measurement accuracy of 0.1 deg. During a 4-hour period of nightly fading, occasional differences in time of arrival were noted that corresponded to a tilt in the north-south alignment of + or - 1 deg. Data from several nights of fading were analyzed, and each night exhibited the same variance in the north-south irregularity alignment. It is postulated that the shift in the measured peak correlation may have been caused by patches of irregularities at different altitudes where the magnetic field lines have a slightly different direction. 13 references

  2. Simulator for beam-based LHC collimator alignment

    Science.gov (United States)

    Valentino, Gianluca; Aßmann, Ralph; Redaelli, Stefano; Sammut, Nicholas

    2014-02-01

    In the CERN Large Hadron Collider, collimators need to be set up to form a multistage hierarchy to ensure efficient multiturn cleaning of halo particles. Automatic algorithms were introduced during the first run to reduce the beam time required for beam-based setup, improve the alignment accuracy, and reduce the risk of human errors. Simulating the alignment procedure would allow for off-line tests of alignment policies and algorithms. A simulator was developed based on a diffusion beam model to generate the characteristic beam loss signal spike and decay produced when a collimator jaw touches the beam, which is observed in a beam loss monitor (BLM). Empirical models derived from the available measurement data are used to simulate the steady-state beam loss and crosstalk between multiple BLMs. The simulator design is presented, together with simulation results and comparison to measurement data.

  3. Energy flow of electric dipole radiation in between parallel mirrors

    Science.gov (United States)

    Xu, Zhangjin; Arnoldus, Henk F.

    2017-11-01

    We have studied the energy flow patterns of the radiation emitted by an electric dipole located in between parallel mirrors. It appears that the field lines of the Poynting vector (the flow lines of energy) can have very intricate structures, including many singularities and vortices. The flow line patterns depend on the distance between the mirrors, the distance of the dipole to one of the mirrors and the angle of oscillation of the dipole moment with respect to the normal of the mirror surfaces. Already for the simplest case of a dipole moment oscillating perpendicular to the mirrors, singularities appear at regular intervals along the direction of propagation (parallel to the mirrors). For a parallel dipole, vortices appear in the neighbourhood of the dipole. For a dipole oscillating under a finite angle with the surface normal, the radiating tends to swirl around the dipole before travelling off parallel to the mirrors. For relatively large mirror separations, vortices appear in the pattern. When the dipole is off-centred with respect to the midway point between the mirrors, the flow line structure becomes even more complicated, with numerous vortices in the pattern, and tiny loops near the dipole. We have also investigated the locations of the vortices and singularities, and these can be found without any specific knowledge about the flow lines. This provides an independent means of studying the propagation of dipole radiation between mirrors.

  4. Lamellar boundary alignment of DS-processed TiAl-W alloys by a solidification procedure

    Science.gov (United States)

    Jung, In-Soo; Oh, Myung-Hoon; Park, No-Jin; Kumar, K. Sharvan; Wee, Dang-Moon

    2007-12-01

    In this study, a β solidification procedure was used to align the lamellae in a Ti-47Al-2W (at.%) alloy parallel to the growth direction. The Bridgman technique and the floating zone process were used for directional solidification. The mechanical properties of the directionally solidified alloy were evaluated in tension at room temperature and at 800°C. At a growth rate of 30 mm/h (with the floating zone approach), the lamellae were well aligned parallel to the growth direction. The aligned lamellae yielded excellent room temperature tensile ductility. The tensile yield strength at 800°C was similar to that at room temperature. The orientation of the γ lamellar laths in the directionally solidified ingots, which were manufactured by means of a floating zone process, was identified with the aid of electron backscattered diffraction analysis. On the basis of this analysis, the preferred growth direction of the bcc-β dendrites that formed at high temperatures close to the melting point was inferred to be [001]β at a growth rate of 30 mm/h and [111]β at a growth rate of 90 mm/h.

  5. Factors driving physician-hospital alignment in orthopaedic surgery.

    Science.gov (United States)

    Page, Alexandra E; Butler, Craig A; Bozic, Kevin J

    2013-06-01

    The relationships between physicians and hospitals are viewed as central to the proposition of delivering high-quality health care at a sustainable cost. Over the last two decades, major changes in the scope, breadth, and complexities of these relationships have emerged. Despite understanding the need for physician-hospital alignment, identification and understanding the incentives and drivers of alignment prove challenging. Our review identifies the primary drivers of physician alignment with hospitals from both the physician and hospital perspectives. Further, we assess the drivers more specific to motivating orthopaedic surgeons to align with hospitals. We performed a comprehensive literature review from 1992 to March 2012 to evaluate published studies and opinions on the issues surrounding physician-hospital alignment. Literature searches were performed in both MEDLINE(®) and Health Business™ Elite. Available literature identifies economic and regulatory shifts in health care and cultural factors as primary drivers of physician-hospital alignment. Specific to orthopaedics, factors driving alignment include the profitability of orthopaedic service lines, the expense of implants, and issues surrounding ambulatory surgery centers and other ancillary services. Evolving healthcare delivery and payment reforms promote increased collaboration between physicians and hospitals. While economic incentives and increasing regulatory demands provide the strongest drivers, cultural changes including physician leadership and changing expectations of work-life balance must be considered when pursuing successful alignment models. Physicians and hospitals view each other as critical to achieving lower-cost, higher-quality health care.

  6. Optical alignment using a CGH and an autostigmatic microscope

    Science.gov (United States)

    Parks, Robert E.

    2017-08-01

    We show how custom computer generated holograms (CGH) are used along with an autostigmatic microscope (ASM) to align both optical and mechanical components relative to the CGH. The patterns in the CGHs define points and lines in space when interrogated with the focus of the ASM. Once the ASM is aligned to the CGH, an optical or mechanical component such as a lens, a well-polished ball or a cylinder can be aligned to the ASM in 3 or 4 degrees of freedom and thus to the CGH. In this case we show how a CGH is used to make a fixture for cementing a doublet lens without the need for a rotary table or a precision vertical stage.

  7. Mn-silicide nanostructures aligned on massively parallel silicon nano-ribbons

    International Nuclear Information System (INIS)

    De Padova, Paola; Ottaviani, Carlo; Ronci, Fabio; Colonna, Stefano; Quaresima, Claudio; Cricenti, Antonio; Olivieri, Bruno; Dávila, Maria E; Hennies, Franz; Pietzsch, Annette; Shariati, Nina; Le Lay, Guy

    2013-01-01

    The growth of Mn nanostructures on a 1D grating of silicon nano-ribbons is investigated at atomic scale by means of scanning tunneling microscopy, low energy electron diffraction and core level photoelectron spectroscopy. The grating of silicon nano-ribbons represents an atomic scale template that can be used in a surface-driven route to control the combination of Si with Mn in the development of novel materials for spintronics devices. The Mn atoms show a preferential adsorption site on silicon atoms, forming one-dimensional nanostructures. They are parallel oriented with respect to the surface Si array, which probably predetermines the diffusion pathways of the Mn atoms during the process of nanostructure formation.

  8. Arioc: high-throughput read alignment with GPU-accelerated exploration of the seed-and-extend search space

    Directory of Open Access Journals (Sweden)

    Richard Wilton

    2015-03-01

    Full Text Available When computing alignments of DNA sequences to a large genome, a key element in achieving high processing throughput is to prioritize locations in the genome where high-scoring mappings might be expected. We formulated this task as a series of list-processing operations that can be efficiently performed on graphics processing unit (GPU hardware.We followed this approach in implementing a read aligner called Arioc that uses GPU-based parallel sort and reduction techniques to identify high-priority locations where potential alignments may be found. We then carried out a read-by-read comparison of Arioc’s reported alignments with the alignments found by several leading read aligners. With simulated reads, Arioc has comparable or better accuracy than the other read aligners we tested. With human sequencing reads, Arioc demonstrates significantly greater throughput than the other aligners we evaluated across a wide range of sensitivity settings. The Arioc software is available at https://github.com/RWilton/Arioc. It is released under a BSD open-source license.

  9. Aligning the unalignable: bacteriophage whole genome alignments.

    Science.gov (United States)

    Bérard, Sèverine; Chateau, Annie; Pompidor, Nicolas; Guertin, Paul; Bergeron, Anne; Swenson, Krister M

    2016-01-13

    In recent years, many studies focused on the description and comparison of large sets of related bacteriophage genomes. Due to the peculiar mosaic structure of these genomes, few informative approaches for comparing whole genomes exist: dot plots diagrams give a mostly qualitative assessment of the similarity/dissimilarity between two or more genomes, and clustering techniques are used to classify genomes. Multiple alignments are conspicuously absent from this scene. Indeed, whole genome aligners interpret lack of similarity between sequences as an indication of rearrangements, insertions, or losses. This behavior makes them ill-prepared to align bacteriophage genomes, where even closely related strains can accomplish the same biological function with highly dissimilar sequences. In this paper, we propose a multiple alignment strategy that exploits functional collinearity shared by related strains of bacteriophages, and uses partial orders to capture mosaicism of sets of genomes. As classical alignments do, the computed alignments can be used to predict that genes have the same biological function, even in the absence of detectable similarity. The Alpha aligner implements these ideas in visual interactive displays, and is used to compute several examples of alignments of Staphylococcus aureus and Mycobacterium bacteriophages, involving up to 29 genomes. Using these datasets, we prove that Alpha alignments are at least as good as those computed by standard aligners. Comparison with the progressive Mauve aligner - which implements a partial order strategy, but whose alignments are linearized - shows a greatly improved interactive graphic display, while avoiding misalignments. Multiple alignments of whole bacteriophage genomes work, and will become an important conceptual and visual tool in comparative genomics of sets of related strains. A python implementation of Alpha, along with installation instructions for Ubuntu and OSX, is available on bitbucket (https://bitbucket.org/thekswenson/alpha).

  10. SMC Progressively Aligns Chromosomal Arms in Caulobacter crescentus but Is Antagonized by Convergent Transcription

    Directory of Open Access Journals (Sweden)

    Ngat T. Tran

    2017-08-01

    Full Text Available The structural maintenance of chromosomes (SMC complex plays an important role in chromosome organization and segregation in most living organisms. In Caulobacter crescentus, SMC is required to align the left and the right arms of the chromosome that run in parallel down the long axis of the cell. However, the mechanism of SMC-mediated alignment of chromosomal arms remains elusive. Here, using genome-wide methods and microscopy of single cells, we show that Caulobacter SMC is recruited to the centromeric parS site and that SMC-mediated arm alignment depends on the chromosome-partitioning protein ParB. We provide evidence that SMC likely tethers the parS-proximal regions of the chromosomal arms together, promoting arm alignment. Furthermore, we show that highly transcribed genes near parS that are oriented against SMC translocation disrupt arm alignment, suggesting that head-on transcription interferes with SMC translocation. Our results demonstrate a tight interdependence of bacterial chromosome organization and global patterns of transcription.

  11. On-line electrochemistry-bioaffinity screening with parallel HR-LC-MS for the generation and characterization of modified p38α kinase inhibitors.

    Science.gov (United States)

    Falck, David; de Vlieger, Jon S B; Giera, Martin; Honing, Maarten; Irth, Hubertus; Niessen, Wilfried M A; Kool, Jeroen

    2012-04-01

    In this study, an integrated approach is developed for the formation, identification and biological characterization of electrochemical conversion products of p38α mitogen-activated protein kinase inhibitors. This work demonstrates the hyphenation of an electrochemical reaction cell with a continuous-flow bioaffinity assay and parallel LC-HR-MS. Competition of the formed products with a tracer (SKF-86002) that shows fluorescence enhancement in the orthosteric binding site of the p38α kinase is the readout for bioaffinity. Parallel HR-MS(n) experiments provided information on the identity of binders and non-binders. Finally, the data produced with this on-line system were compared to electrochemical conversion products generated off-line. The electrochemical conversion of 1-{6-chloro-5-[(2R,5S)-4-(4-fluorobenzyl)-2,5-dimethylpiperazine-1-carbonyl]-3aH-indol-3-yl}-2-morpholinoethane-1,2-dione resulted in eight products, three of which showed bioaffinity in the continuous-flow p38α bioaffinity assay used. Electrochemical conversion of BIRB796 resulted, amongst others, in the formation of the reactive quinoneimine structure and its corresponding hydroquinone. Both products were detected in the p38α bioaffinity assay, which indicates binding to the p38α kinase.

  12. Three-dimensional parallel vortex rings in Bose-Einstein condensates

    International Nuclear Information System (INIS)

    Crasovan, Lucian-Cornel; Perez-Garcia, Victor M.; Danaila, Ionut; Mihalache, Dumitru; Torner, Lluis

    2004-01-01

    We construct three-dimensional structures of topological defects hosted in trapped wave fields, in the form of vortex stars, vortex cages, parallel vortex lines, perpendicular vortex rings, and parallel vortex rings, and we show that the latter exist as robust stationary, collective states of nonrotating Bose-Einstein condensates. We discuss the stability properties of excited states containing several parallel vortex rings hosted by the condensate, including their dynamical and structural stability

  13. Alignment in double capture processes

    Energy Technology Data Exchange (ETDEWEB)

    Moretto-Capelle, P.; Benhenni, M.; Bordenave-Montesquieu, A.; Benoit-Cattin, P.; Gleizes, A. (IRSAMC, URA CNRS 770, Univ. Paul Sabatier, 118 rte de Narbonne, 31062 Toulouse Cedex (France))

    1993-06-05

    The electron spectra emitted when a double capture occurs in N[sup 7+]+He and Ne[sup 8+]+He systems at 10 qkeV collisional energy, allow us to determine the angular distributions of the 3[ell]3[ell] [prime] lines through a special spectra fitting procedure which includes interferences between neighbouring states. It is found that the doubly excited states populated in double capture processes are generally aligned.

  14. FSO tracking and auto-alignment transceiver system

    Science.gov (United States)

    Cap, Gabriel A.; Refai, Hakki H.; Sluss, James J., Jr.

    2008-10-01

    Free-space optics (FSO) technology utilizes a modulated light beam to transmit information through the atmosphere. Due to reduced size and cost, and higher data rates, FSO can be more effective than wireless communication. Although atmospheric conditions can affect FSO communication, a line-of-sight connection between FSO transceivers is a necessary condition to maintain continuous exchange of data, voice, and video information. To date, the primary concentration of mobile FSO research and development has been toward accurate alignment between two transceivers. This study introduces a fully automatic, advanced alignment system that will maintain a line of sight connection for any FSO transceiver system. A complete transceiver system includes a position-sensing detector (PSD) to receive the signal, a laser to transmit the signal, a gimbal to move the transceiver to maintain alignment, and a computer to coordinate the necessary movements during motion. The FSO system was tested for mobility by employing one gimbal as a mobile unit and establishing another as a base station. Tests were performed to establish that alignment between two transceivers could be maintained during a given period of experiments and to determine the maximum speeds tolerated by the system. Implementation of the transceiver system can be realized in many ways, including vehicle-to-base station communication or vehicle-to-vehicle communication. This study is especially promising in that it suggests such a system is able to provide high-speed data in many applications where current wireless technology may not be effective. This phenomenon, coupled with the ability to maintain an autonomously realigned connection, opens the possibility of endless applications for both military and civilian use.

  15. All about alignment

    CERN Multimedia

    2006-01-01

    The ALICE absorbers, iron wall and superstructure have been installed with great precision. The ALICE front absorber, positioned in the centre of the detector, has been installed and aligned. Weighing more than 400 tonnes, the ALICE absorbers and the surrounding support structures have been installed and aligned with a precision of 1-2 mm, hardly an easy task but a very important one. The ALICE absorbers are made of three parts: the front absorber, a 35-tonne cone-shaped structure, and two small-angle absorbers, long straight cylinder sections weighing 18 and 40 tonnes. The three pieces lined up have a total length of about 17 m. In addition to these, ALICE technicians have installed a 300-tonne iron filter wall made of blocks that fit together like large Lego pieces and a surrounding metal support structure to hold the tracking and trigger chambers. The absorbers house the vacuum chamber and are also the reference surface for the positioning of the tracking and trigger chambers. For this reason, the ab...

  16. The field-aligned currents observed by JIKIKEN

    International Nuclear Information System (INIS)

    Aoyama, I.; Toyama, F.; Takahashi, T.; Sakurai, T.; Tonegawa, Y.

    1979-01-01

    New substorm effects on field-aligned current which belongs to a magnetic shell at L asymptotically equals 6 are found in the records from the fluxgate magnetometer on board the scientific satellite, JIKIKEN. The deviation from base line in the magnetometer data seems to be enhanced associating with the substorm onset. (author)

  17. VUV treatment combined with mechanical strain of stretchable polymer foils resulting in cell alignment

    Energy Technology Data Exchange (ETDEWEB)

    Barb, R.-A. [Institute of Applied Physics, Johannes Kepler University Linz (Austria); Magnus, B. [Innovacell Biotechnologie AG, Innsbruck (Austria); Innerbichler, S. [Innerbichler GmbH, Breitenbach am Inn (Austria); Greunz, T. [CDL-MS-MACH, Johannes Kepler University Linz (Austria); Wiesbauer, M. [Institute of Applied Physics, Johannes Kepler University Linz (Austria); Marksteiner, R. [Innovacell Biotechnologie AG, Innsbruck (Austria); Stifter, D. [CDL-MS-MACH, Johannes Kepler University Linz (Austria); Heitz, J., E-mail: johannes.heitz@jku.at [Institute of Applied Physics, Johannes Kepler University Linz (Austria)

    2015-01-15

    Highlights: • Elastic polyurethane (PU) foils were exposed to the vacuum-UV in reactive atmosphere. • The photomodification resulted in improved cytocompatibilty. • Parallel microgrooves formed on the irradiated PU surfaces after strong elongation. • Cells seeded onto microgrooves aligned their shapes in the direction of the grooves. • Elongation occurred also for cells on PU subjected to cyclic mechanical stretching. - Abstract: Cell-alignment along a defined direction can have a direct effect on the cell functionality and differentiation. Oriented micro- or nanotopographic structures on cell culture substrates can induce cell-alignment. Surface chemistry, wettability, and stiffness of the substrate are also important material features as they strongly influence the cell–substrate interactions. For improved bio-compatibility, highly elastic polyurethane (PU) foils were exposed to the vacuum-UV (VUV) light of a Xe{sub 2}{sup *} excimer lamp at 172 nm in a nitrogen containing atmosphere (N{sub 2} or NH{sub 3}). The irradiation resulted in a change in the chemical surface composition. Additionally, the formation of regular parallel microgrooves was observed on the irradiated surfaces after strong uni-axial deformation (i.e., more than about 50% strain) of the photo-modified PU foils. Cell seeding experiments demonstrated that the VUV modified polymer foils strongly enhance cell adhesion and proliferation. Cells seeded onto microgrooves aligned their shapes and elongated in the direction of the grooves. A similar effect was observed for cells seeded on photo-modified PU foils subjected to cyclic mechanical stretching at lower strain levels (i.e., typically 10% strain) without groove-formation. The cells had also here an elongated shape, however they not always align in a defined direction relative to the stretching.

  18. Study on orientation mechanisms of poly(vinylidenefluoride-trifluoroethylene) molecules aligned by atomic force microscopy

    International Nuclear Information System (INIS)

    Kimura, Kuniko; Kobayashi, Kei; Yamada, Hirofumi; Horiuchi, Toshihisa; Ishida, Kenji; Matsushige, Kazumi

    2006-01-01

    We have developed a molecular orientation control technique for polymers utilizing contact-mode atomic force microscopy (AFM). In this paper, we studied the molecular alignment mechanism of this technique by applying it to poly(vinylidenefluoride-trifluoroethylene) (P(VDF-TrFE)). The resultant alignment and formed crystal size were strongly dependent on the temperature during the modification. They also depended on the scan line spacing of the modification. These results made the alignment mechanism clear. The obtained molecular alignment was stable against the heat treatment even at the temperatures just below T m

  19. The role of magnetic-field-aligned electric fields in auroral acceleration

    International Nuclear Information System (INIS)

    Block, L.P.; Faelthammar, C.G.

    1990-01-01

    Electric field measurements on the Swedish satellite Viking have confirmed and extended earlier observations on S3-3 and provided further evidence of the role of dc electric fields in auroral acceleration processes. On auroral magnetic field lines the electric field is strongly fluctuating both transverse and parallel to the magnetic field. The significance of these fluctuations for the auroral acceleration process is discussed. A definition of dc electric fields is given in terms of their effects on charged particles. Fluctuations below several hertz are experienced as dc by typical auroral electrons if the acceleration length is a few thousand kilometers. For ions the same is true below about 0.1 Hz. The magnetic-field-aligned (as well as the transverse) component of the electric field fluctuations has a maximum below 1 Hz, in a frequency range that appears as dc to the electrons but not to the ions. This allows it to cause a selective acceleration, which may be important in explaining some of the observed characteristics of auroral particle distributions. The electric field observations on Viking support the conclusion that magnetic-field-aligned potential drops play an important role in auroral acceleration, in good agreement with particle observations boht on Viking and on the DE satellites. They also show that a large part, or even all, of the accelerating potential drop may be accounted for by numerous weak (about a volt) electric double layers, in agreement with earlier observations on the S3-3 satellite and with an early theoretical suggestion by L. Block

  20. New overlay measurement technique with an i-line stepper using embedded standard field image alignment marks for wafer bonding applications

    Science.gov (United States)

    Kulse, P.; Sasai, K.; Schulz, K.; Wietstruck, M.

    2017-06-01

    marks. In this work, the non-contact infrared alignment system of the Nikon i-line Stepper NSR-SF150 for both the alignment and the overlay determination of bonded wafer stacks with embedded alignment marks are used to achieve an accurate alignment between the different wafer sides. The embedded field image alignment (FIA) marks of the interface and the device wafer top layer are measured in a single measurement job. By taking the offsets between all different FIA's into account, after correcting the wafer rotation induced FIA position errors, hence an overlay for the stacked wafers can be determined. The developed approach has been validated by a standard back to front side application. The overlay was measured and determined using both, the EVG NT40 automated measurement system with special overlay marks and the measurement of the FIA marks of the front and back side layer. A comparison of both results shows mismatches in x and y translations smaller than 200 nm, which is relatively small compared to the overlay tolerances of +/-500 nm for the back to front side process. After the successful validation of the developed technique, special wafer stacks with FIA alignment marks in the bonding interface are fabricated. Due to the super IR light transparency of both doubled side polished wafers, the embedded FIA marks generate a stable and clear signal for accurate x and y wafer coordinate positioning. The FIA marks of the device wafer top layer were measured under standard condition in a developed photoresist mask without IR illumination. Following overlay calculation shows an overlay of less than 200 nm, which enables very accurate process condition for highly scaled TSV integration and advanced substrate integration into IHP's 0.25/0.13 μm SiGe:C BiCMOS technology. The presented method can be applied for both the standard back to front side process technologies and also new temporary and permanent wafer bonding applications.

  1. Illustrative Line Styles for Flow Visualization

    NARCIS (Netherlands)

    Everts, Maarten H.; Bekker, Hendrik; Roerdink, Jos B. T. M.; Isenberg, Tobias

    2011-01-01

    We present a flexible illustrative line style model for the visualization of streamline data. Our model partitions view-oriented line strips into parallel bands whose basic visual properties can be controlled independently. We thus extend previous line stylization techniques specifically for

  2. Flow Visualization using Illustrative Line Styles

    NARCIS (Netherlands)

    Everts, Maarten H.; Bekker, Hendrik; Roerdink, Jos B. T. M.; Isenberg, Tobias; Bekker, Paulus

    2011-01-01

    We present a flexible illustrative line style model for the visualization of streamline data. Our model partitions view- oriented line strips into parallel bands whose basic visual properties can be controlled independently. We thus extend previous line stylization techniques specifically for

  3. Laser alignment of rotating equipment at PNL

    International Nuclear Information System (INIS)

    Berndt, R.H.

    1994-05-01

    Lateral vibration in direct-drive equipment is usually caused by misalignment. Over the years, because of the need to improve on techniques and ways of working more efficiently, various types of alignment methods have evolved. In the beginning, craftsmen used a straight-edge scale across the coupling with a feeler gauge measuring the misalignment error. This is still preferred today for aligning small couplings. The industry has since decided that alignment of large direct-drive equipment needed a more accurate type of instrumentation. Rim and face is another of the first alignment methods and is used on all sizes of equipment. A disadvantage of the rim and face method is that in most cases the coupling has to be disassembled. This can cause alignment problems when the coupling is reassembled. Also, the rim and face method is not fast enough to work satisfactorily on alignment of thermally hot equipment. Another concern is that the coupling has to be manufactured accurately for correct rim and face readings. Reverse dial alignment is an improvement over the rim and face method, and depending on the operator's experience, this method can be very accurate. A good training program along with field experience will bring the operator to a proper level of proficiency for a successful program. A hand-held computer with reverse dial calculations in memory is a must for job efficiency. An advantage over the rim and face method is that the coupling is not disassembled and remains locked together. Reverse dial instrumentation measures from both shaft center lines, rather than the coupling surface so the machining of the coupling during manufacture is not a major concern

  4. NUMERICAL SIMULATION OF THREE-DIMENSIONAL ASYMMETRIC RECONNECTION AND APPLICATION TO A PHYSICAL MECHANISM OF PENUMBRAL MICROJETS

    International Nuclear Information System (INIS)

    Nakamura, Naoki; Shibata, Kazunari; Isobe, Hiroaki

    2012-01-01

    Three-dimensional (3D) component reconnection, where reconnecting field lines are not perfectly anti-parallel, is studied with a 3D magnetohydrodynamic simulation. In particular, we consider the asymmetry of the field strength of the reconnecting field lines. As the asymmetry increases, the generated reconnection jet tends to be parallel to stronger field lines. This is because weaker field lines have higher gas pressure in the initial equilibrium, and hence the gas pressure gradient along the reconnected field lines is generated, which accelerates the field-aligned plasma flow. This mechanism may explain penumbral microjets and other types of jets that are parallel to magnetic field lines.

  5. Canyval-x: Cubesat Astronomy by NASA and Yonsei Using Virtual Telescope Alignment Experiment

    Science.gov (United States)

    Shah, Neerav

    2016-01-01

    CANYVAL-X is a technology demonstration CubeSat mission with a primary objective of validating technologies that allow two spacecraft to fly in formation along an inertial line-of-sight (i.e., align two spacecraft to an inertial source). Demonstration of precision dual-spacecraft alignment achieving fine angular precision enables a variety of cutting-edge heliophysics and astrophysics science.

  6. Monitoring of absolute mirror alignment at COMPASS RICH-1 detector

    Energy Technology Data Exchange (ETDEWEB)

    Alexeev, M. [INFN, Sezione di Torino and University of East Piemonte, Alessandria (Italy); INFN, Sezione di Trieste and University of Bari, Bari (Italy); Birsa, R. [INFN, Sezione di Trieste, Trieste (Italy); Bradamante, F.; Bressan, A. [INFN, Sezione di Trieste and University of Trieste, Trieste (Italy); Chiosso, M. [INFN, Sezione di Torino and University of Torino, Torino (Italy); Ciliberti, P. [INFN, Sezione di Trieste and University of Trieste, Trieste (Italy); Dalla Torre, S. [INFN, Sezione di Trieste, Trieste (Italy); Denisov, O. [INFN, Sezione di Torino, Torino (Italy); Duic, V. [INFN, Sezione di Trieste and University of Trieste, Trieste (Italy); Ferrero, A. [INFN, Sezione di Torino and University of Torino, Torino (Italy); Finger, M.; Finger, M. [Charles University, Prague (Czech Republic); JINR, Dubna (Russian Federation); Gayde, J.Ch. [CERN, European Organization for Nuclear Research, Geneva (Switzerland); Giorgi, M. [INFN, Sezione di Trieste and University of Trieste, Trieste (Italy); Gobbo, B.; Levorato, S. [INFN, Sezione di Trieste, Trieste (Italy); Maggiora, A. [INFN, Sezione di Torino, Torino (Italy); Martin, A. [INFN, Sezione di Trieste and University of Trieste, Trieste (Italy); Menon, G. [INFN, Sezione di Trieste, Trieste (Italy); Panzieri, D. [INFN, Sezione di Torino and University of East Piemonte, Alessandria (Italy); and others

    2014-12-01

    The gaseous COMPASS RICH-1 detector uses two spherical mirror surfaces, segmented into 116 individual mirrors, to focus the Cherenkov photons onto the detector plane. Any mirror misalignment directly affects the detector resolution. The on-line Continuous Line Alignment and Monitoring (CLAM) photogrammetry-based method has been implemented to measure the alignment of individual mirrors which can be characterized by the center of curvature. The mirror wall reflects a regular grid of retroreflective strips placed inside the detector vessel. Then, the position of each mirror is determined from the image of the grid reflection. The images are collected by four cameras. Any small mirror misalignment results in changes of the grid lines’ positions in the image. The accuracy limits of the CLAM method were checked by laser interferometry and are below 0.1 mrad.

  7. Millimeter wave surface resistance of grain-aligned Y1Ba2Cu3O(x) bulk material

    International Nuclear Information System (INIS)

    Wosik, J.; Kranenburg, R.A.; Wolfe, J.C.; Selvamanickam, V.; Salama, K.

    1990-04-01

    Measurements are reported of the millimeter-wave surface resistance of grain-aligned YBa2Cu3O(x) bulk material grown by a liquid-phase process. The measurements were performed by replacing the endplate of a TE(011) cylindrical copper cavity with the superconducting sample. Surface resistance was measured for samples with surfaces oriented perpendicular and parallel to the c-axis of the grains. For the parallel configuration, the surface resistance at 77 K and 80 GHz is given. For a very well-aligned sample with a very low density of Y2BaCuO(y) precipitates, measured in the perpendicular configuration, the transition width (10-90 percent) is about 2 K and the surface resistance is derived at 88 K. The effect of microstructure on surface resistance is discussed. 19 refs

  8. Preparation and gas-sensing property of parallel-aligned ZnO ...

    Indian Academy of Sciences (India)

    binding energy (60 meV) and a large bandgap (3·37 eV) energy, has many ... Con- siderable efforts have been made to fabricate ZnO nanowires, nanobelts .... In such a case, the data could be fitted to a straight line .... The re-oxidation pro-.

  9. Introduction of hind foot coronal alignment view

    International Nuclear Information System (INIS)

    Moon, Il Bong; Jeon, Ju Seob; Yoon, Kang Cheol; Choi, Nam Kil; Kim, Seung Kook

    2006-01-01

    Accurate clinical evaluation of the alignment of the calcaneus relative to the tibia in the coronal plane is essential in the evaluation and treatment of hind foot pathologic condition. Previously described standard anteroposterior, lateral, and oblique radiographic methods of the foot or ankle do not demonstrate alignment of the tibia relation to the calcaneus in the coronal plane. The purpose of this study was to introduce hind foot coronal alignment view. Both feet were imaged simultaneously on an elevated, radiolucent foot stand equipment. Both feet stood on a radiolucent platform with equal weight on both feet. Both feet are located foot axis longitudinal perpendicular to the platform. Silhouette tracing around both feet are made, and line is then drawn to bisect the silhouette of the second toe and the outline of the heel. The x-ray beam is angled down approximately 15 .deg. to 20 .deg. This image described tibial axis and medial, lateral tuberosity of calcaneus. Calcaneus do not rotated. The view is showed by talotibial joint space. Although computed tomographic and magnetic resonance imaging techniques are capable of demonstrating coronal hind foot alignment, they lack usefulness in most clinical situations because the foot is imaged in a non-weight bearing position. But hind foot coronal alignment view is obtained for evaluating position changing of inversion, eversion of the hind foot and varus, valgus deformity of calcaneus

  10. AlignMe—a membrane protein sequence alignment web server

    Science.gov (United States)

    Stamm, Marcus; Staritzbichler, René; Khafizov, Kamil; Forrest, Lucy R.

    2014-01-01

    We present a web server for pair-wise alignment of membrane protein sequences, using the program AlignMe. The server makes available two operational modes of AlignMe: (i) sequence to sequence alignment, taking two sequences in fasta format as input, combining information about each sequence from multiple sources and producing a pair-wise alignment (PW mode); and (ii) alignment of two multiple sequence alignments to create family-averaged hydropathy profile alignments (HP mode). For the PW sequence alignment mode, four different optimized parameter sets are provided, each suited to pairs of sequences with a specific similarity level. These settings utilize different types of inputs: (position-specific) substitution matrices, secondary structure predictions and transmembrane propensities from transmembrane predictions or hydrophobicity scales. In the second (HP) mode, each input multiple sequence alignment is converted into a hydrophobicity profile averaged over the provided set of sequence homologs; the two profiles are then aligned. The HP mode enables qualitative comparison of transmembrane topologies (and therefore potentially of 3D folds) of two membrane proteins, which can be useful if the proteins have low sequence similarity. In summary, the AlignMe web server provides user-friendly access to a set of tools for analysis and comparison of membrane protein sequences. Access is available at http://www.bioinfo.mpg.de/AlignMe PMID:24753425

  11. Millimeter wave surface resistance of grain-aligned Y1Ba2Cu3Ox bulk material

    International Nuclear Information System (INIS)

    Wosik, J.; Kranenburg, R.A.; Wolfe, J.C.; Selvamanickam, V.; Salama, K.

    1991-01-01

    We report measurements of the millimeter wave surface resistance of grain-aligned YBa 2 Cu 3 O x bulk material grown by a liquid phase process. The measurements were performed by replacing the endplate of a TE 011 cylindrical copper cavity with the superconducting sample. Surface resistance was measured for samples with surfaces oriented perpendicular and parallel to the c-axis of the grains. We show that, for the parallel configuration, the surface resistance at 77 K and 80 GHz is typically near 100 mΩ. For a very well-aligned sample with a very low density of Y 2 BaCuO y precipitates, measured in the perpendicular configuration, the transition width (10%--90%) is about 2 K and the surface resistance is less than 50 mΩ at 88 K. The effect of microstructure on surface resistance is discussed

  12. Directional cell migration establishes the axes of planar polarity in the posterior lateral-line organ of the zebrafish.

    Science.gov (United States)

    López-Schier, Hernán; Starr, Catherine J; Kappler, James A; Kollmar, Richard; Hudspeth, A J

    2004-09-01

    The proper orientation of mechanosensory hair cells along the lateral-line organ of a fish or amphibian is essential for the animal's ability to sense directional water movements. Within the sensory epithelium, hair cells are polarized in a stereotyped manner, but the mechanisms that control their alignment relative to the body axes are unknown. We have found, however, that neuromasts can be oriented either parallel or perpendicular to the anteroposterior body axis. By characterizing the strauss mutant zebrafish line and by tracking labeled cells, we have demonstrated that neuromasts of these two orientations originate from, respectively, the first and second primordia. Furthermore, altering the migratory pathway of a primordium reorients a neuromast's axis of planar polarity. We propose that the global orientation of hair cells relative to the body axes is established through an interaction between directional movement by primordial cells and the timing of neuromast maturation.

  13. Sagittal Alignment As a Predictor of Clinical Adjacent Segment Pathology requiring Surgery after Anterior Cervical Arthrodesis

    Science.gov (United States)

    Park, Moon Soo; Kelly, Michael P.; Lee, Dong-Ho; Min, Woo-Kie; Rahman, Ra’Kerry K.; Riew, K. Daniel

    2014-01-01

    BACKGROUND CONTEXT Postoperative malalignment of the cervical spine may alter cervical spine mechanics, and put patients at risk for clinical adjacent segment pathology requiring surgery. PURPOSE To investigate whether a relationship exists between cervical spine sagittal alignment and clinical adjacent segment pathology requiring surgery (CASP-S) following anterior cervical fusion (ACF). STUDY DESIGN Retrospective matched study. PATIENT SAMPLE One hundred twenty two patients undergoing ACF from 1996 to 2008 were identified, with a minimum of 2 year follow-up. OUTCOME MEASURES Radiographs were reviewed to measure the sagittal alignment using C2 and C7 sagittal plumb lines, distance from the fusion mass plumb line to the C2 and C7 plumb lines, the alignment of the fusion mass, caudally adjacent disc angle, the sagittal slope angle of the superior endplate of the vertebra caudally adjacent to the fusion mass, T1 sagittal angle, overall cervical sagittal alignment, and curve patterns by Katsuura classification. METHODS One hundred twenty two patients undergoing ACF from 1996 to 2008 were identified, with a minimum of 1 year follow-up. Patients were divided into groups according to the development of CASP requiring surgery (Control / CASP-S) and by number/location of levels fused. Radiographs were reviewed to measure the sagittal alignment using C2 and C7 sagittal plumb lines, distance from the fusion mass plumb line to the C2 and C7 plumb lines, the alignment of the fusion mass, caudally adjacent disc angle, the sagittal slope angle of the superior endplate of the vertebra caudally adjacent to the fusion mass, T1 sagittal angle, overall cervical sagittal alignment, and curve patterns by Katsuura classification. Appropriate statistical tests were performed to calculate relationships between the variables and the development of CASP-S. No funds were received in support of this work. No benefits in any form have been or will be received from a commercial party related

  14. The Rail Alignment Environmental Impact Statement: An Update

    International Nuclear Information System (INIS)

    Sweeney, R.

    2005-01-01

    scenario, the DOE would rely on a combination of rail, truck and possibly barge to transport to the repository site at Yucca Mountain up to 70,000 MTHM of spent nuclear fuel and high-level radioactive waste, with most of the spent nuclear fuel and high-level radioactive waste being transported by rail. This will ultimately require construction of a rail line in Nevada to the repository. In addition, the DOE has decided to select the Caliente rail corridor in which to examine potential alignments within which to construct that rail line. A corridor is a strip of land, approximately 400 meters (0.25 miles) wide, that encompasses one of several possible routes through which DOE could build a rail line. An alignment is the specific location of a rail line in a corridor, and would likely be 60 meters [200 feet] or less in width. Also on April 8, 2004, DOE issued a Notice of Intent to Prepare an Environmental Impact Statement for the Alignment, Construction, and Operation of a Rail Line to a Geologic Repository at Yucca Mountain, Nye County, NV. In the Notice of Intent, the Department announced its intent to prepare a Rail Alignment EIS to assist in selecting a possible alignment for construction of a rail line that would connect the repository at Yucca Mountain to an existing main rail line in Nevada. The Rail Alignment EIS also would consider the potential construction and operation of a rail-to-truck intermodal transfer facility, proposed to be located at the confluence of an existing mainline railroad and a highway, to support legal-weight truck transportation until the rail system is fully operational. This corridor is approximately 513 kilometers (319 miles) long and would cost an estimated $880 million (2001 dollars). Should DOE decide to build the Caliente corridor, it may be the longest rail line built in the United States since the Transcontinental Railroad was constructed in 1869. Some of the challenges in building this rail corridor are steep grades (the corridor

  15. Title: Using Alignment and 2D Network Simulations to Study Charge Transport Through Doped ZnO Nanowire Thin Film Electrodes

    KAUST Repository

    Phadke, Sujay

    2011-09-30

    Factors affecting charge transport through ZnO nanowire mat films were studied by aligning ZnO nanowires on substrates and coupling experimental measurements with 2D nanowire network simulations. Gallium doped ZnO nanowires were aligned on thermally oxidized silicon wafer by shearing a nanowire dispersion in ethanol. Sheet resistances of nanowire thin films that had current flowing parallel to nanowire alignment direction were compared to thin films that had current flowing perpendicular to nanowire alignment direction. Perpendicular devices showed ∼5 fold greater sheet resistance than parallel devices supporting the hypothesis that aligning nanowires would increase conductivity of ZnO nanowire electrodes. 2-D nanowire network simulations of thin films showed that the device sheet resistance was dominated by inter-wire contact resistance. For a given resistivity of ZnO nanowires, the thin film electrodes would have the lowest possible sheet resistance if the inter-wire contact resistance was one order of magnitude lower than the single nanowire resistance. Simulations suggest that the conductivity of such thin film devices could be further enhanced by using longer nanowires. Solution processed Gallium doped ZnO nanowires are aligned on substrates using an innovative shear coating technique. Nanowire alignment has shown improvement in ZnO nanowire transparent electrode conductivity. 2D network simulations in conjunction with electrical measurements have revealed different regimes of operation of nanowire thin films and provided a guideline for improving electrical performance of nanowire electrodes. Copyright © 2011 WILEY-VCH Verlag GmbH & Co. KGaA, Weinheim.

  16. Alignment between galaxies and large-scale structure

    International Nuclear Information System (INIS)

    Faltenbacher, A.; Li Cheng; White, Simon D. M.; Jing, Yi-Peng; Mao Shude; Wang Jie

    2009-01-01

    Based on the Sloan Digital Sky Survey DR6 (SDSS) and the Millennium Simulation (MS), we investigate the alignment between galaxies and large-scale structure. For this purpose, we develop two new statistical tools, namely the alignment correlation function and the cos(2θ)-statistic. The former is a two-dimensional extension of the traditional two-point correlation function and the latter is related to the ellipticity correlation function used for cosmic shear measurements. Both are based on the cross correlation between a sample of galaxies with orientations and a reference sample which represents the large-scale structure. We apply the new statistics to the SDSS galaxy catalog. The alignment correlation function reveals an overabundance of reference galaxies along the major axes of red, luminous (L ∼ * ) galaxies out to projected separations of 60 h- 1 Mpc. The signal increases with central galaxy luminosity. No alignment signal is detected for blue galaxies. The cos(2θ)-statistic yields very similar results. Starting from a MS semi-analytic galaxy catalog, we assign an orientation to each red, luminous and central galaxy, based on that of the central region of the host halo (with size similar to that of the stellar galaxy). As an alternative, we use the orientation of the host halo itself. We find a mean projected misalignment between a halo and its central region of ∼ 25 deg. The misalignment decreases slightly with increasing luminosity of the central galaxy. Using the orientations and luminosities of the semi-analytic galaxies, we repeat our alignment analysis on mock surveys of the MS. Agreement with the SDSS results is good if the central orientations are used. Predictions using the halo orientations as proxies for central galaxy orientations overestimate the observed alignment by more than a factor of 2. Finally, the large volume of the MS allows us to generate a two-dimensional map of the alignment correlation function, which shows the reference

  17. A numerical model of ionospheric convection derived from field-aligned currents and the corresponding conductivity

    International Nuclear Information System (INIS)

    Blomberg, L.G.; Marklund, G.T.

    1991-08-01

    A numerical model for the calculation of ionospheric convection patterns from given distributions of field-aligned current and ionospheric conductivity is described. The model includes a coupling between the conductivity and the field-aligned current, so that the conductivity peaks in regions of upward current, as is usually observed by measurements. The model is very flexible in that the input distributions, the field-aligned current and the conductivity, have been parametrized in a convenient way. From the primary model output, namely the ionospheric electrostatic potential (or convection) in the corotating frame, a number of other quantities can be computed. These include; the potential in the inertial frame (the transformation takes into account the non-alignment of the Earths magnetic and geographic axes), the potential in the magnetospheric equatorial plane (projected using either a dipole magnetic field model or the Tsyganenko-Usmanov model, and the assumption of either vanishing parallel electric field or a proportionality between parallel potential and upward field-aligned current), the distribution of ionospheric (horizontal) current, and the Joule heating in the ionosphere. This model has been used together with a new snapshot technique to calculate the high-latitude potential distribution prevailing during a particular event by combining information from global auroral images and local measurements of fields and particles. The model potential variation along the satellite orbit was found to be in excellent agreement with that calculated from the measured electric field. The model has also been used to study some fundamental properties of the electrodynamics of the high-latitude ionosphere. The results of these different applications of the model have been published separately. (au) (39 refs.)

  18. Design of a planar 3-DOF parallel micromanipulator

    International Nuclear Information System (INIS)

    Lee, Jeong Jae; Dong, Yanlu; Jeon, Yong Ho; Lee, Moon Gu

    2013-01-01

    A planar three degree-of-freedom (DOF) parallel manipulator is proposed to be applied for alignment during assembly of microcomponents. It adopts a PRR (prismatic-revolute-revolute) mechanism to meet the requirements of high precision for assembly and robustness against disturbance. The mechanism was designed to have a large workspace and good dexterity because parallel mechanisms usually have a narrow range and singularity of motion compared to serial mechanisms. Inverse kinematics and a simple closed-loop algorithm of the parallel manipulator are presented to control it. Experimental tests have been carried out with high-resolution capacitance sensors to verify the performance of the mechanism. The results of experiments show that the manipulator has a large workspace of ±1.0 mm, ±1.0 mm, and ±10 mrad in the X-, Y-, and θ-directions, respectively. This is a large workspace when considering it adopts a parallel mechanism and has a small size, 100 ´ 100 ´ 100 mm3 . It also has a good precision of 2 μm, 3 μm, and 0.2 mrad, in the X-, Y-, and θ- axes, respectively. These are high resolutions considering the manipulator adopts conventional joints. The manipulator is expected to have good dexterity.

  19. GraphAlignment: Bayesian pairwise alignment of biological networks

    Directory of Open Access Journals (Sweden)

    Kolář Michal

    2012-11-01

    Full Text Available Abstract Background With increased experimental availability and accuracy of bio-molecular networks, tools for their comparative and evolutionary analysis are needed. A key component for such studies is the alignment of networks. Results We introduce the Bioconductor package GraphAlignment for pairwise alignment of bio-molecular networks. The alignment incorporates information both from network vertices and network edges and is based on an explicit evolutionary model, allowing inference of all scoring parameters directly from empirical data. We compare the performance of our algorithm to an alternative algorithm, Græmlin 2.0. On simulated data, GraphAlignment outperforms Græmlin 2.0 in several benchmarks except for computational complexity. When there is little or no noise in the data, GraphAlignment is slower than Græmlin 2.0. It is faster than Græmlin 2.0 when processing noisy data containing spurious vertex associations. Its typical case complexity grows approximately as O(N2.6. On empirical bacterial protein-protein interaction networks (PIN and gene co-expression networks, GraphAlignment outperforms Græmlin 2.0 with respect to coverage and specificity, albeit by a small margin. On large eukaryotic PIN, Græmlin 2.0 outperforms GraphAlignment. Conclusions The GraphAlignment algorithm is robust to spurious vertex associations, correctly resolves paralogs, and shows very good performance in identification of homologous vertices defined by high vertex and/or interaction similarity. The simplicity and generality of GraphAlignment edge scoring makes the algorithm an appropriate choice for global alignment of networks.

  20. High-resolution accelerator alignment using x-ray optics

    Directory of Open Access Journals (Sweden)

    Bingxin Yang

    2006-03-01

    Full Text Available We propose a novel alignment technique utilizing the x-ray beam of an undulator in conjunction with pinholes and position-sensitive detectors for positioning components of the accelerator, undulator, and beam line in an x-ray free-electron laser. Two retractable pinholes at each end of the undulator define a stable and reproducible x-ray beam axis (XBA. Targets are precisely positioned on the XBA using a pinhole camera technique. Position-sensitive detectors responding to both x-ray and electron beams enable direct transfer of the position setting from the XBA to the electron beam. This system has the potential to deliver superior alignment accuracy (1–3   μm for target pinholes in the transverse directions over a long distance (200 m or longer. It can be used to define the beam axis of the electron-beam–based alignment, enabling high reproducibility of the latter. This x-ray–based concept should complement the electron-beam–based alignment and the existing survey methods to raise the alignment accuracy of long accelerators to an unprecedented level. Further improvement of the transverse accuracy using x-ray zone plates will be discussed. We also propose a concurrent measurement scheme during accelerator operation to allow real-time feedback for transverse position correction.

  1. Eccentric vision : adverse interactions between line segments

    NARCIS (Netherlands)

    Andriessen, J.J.; Bouma, H.

    1976-01-01

    The paper deals with adverse interactions between line stimuli ineccentric vision. Bothcontrast thresholdandjust noticeable difference of slanthave been measured for a test line as a function of the distance from a number of surrounding lines. Test lines were either parallel or perpendicular to the

  2. Similarities and differences between helminth parasites and cancer cell lines in shaping human monocytes: Insights into parallel mechanisms of immune evasion.

    Directory of Open Access Journals (Sweden)

    Prakash Babu Narasimhan

    2018-04-01

    Full Text Available A number of features at the host-parasite interface are reminiscent of those that are also observed at the host-tumor interface. Both cancer cells and parasites establish a tissue microenvironment that allows for immune evasion and may reflect functional alterations of various innate cells. Here, we investigated how the phenotype and function of human monocytes is altered by exposure to cancer cell lines and if these functional and phenotypic alterations parallel those induced by exposure to helminth parasites. Thus, human monocytes were exposed to three different cancer cell lines (breast, ovarian, or glioblastoma or to live microfilariae (mf of Brugia malayi-a causative agent of lymphatic filariasis. After 2 days of co-culture, monocytes exposed to cancer cell lines showed markedly upregulated expression of M1-associated (TNF-α, IL-1β, M2-associated (CCL13, CD206, Mreg-associated (IL-10, TGF-β, and angiogenesis associated (MMP9, VEGF genes. Similar to cancer cell lines, but less dramatically, mf altered the mRNA expression of IL-1β, CCL13, TGM2 and MMP9. When surface expression of the inhibitory ligands PDL1 and PDL2 was assessed, monocytes exposed to both cancer cell lines and to live mf significantly upregulated PDL1 and PDL2 expression. In contrast to exposure to mf, exposure to cancer cell lines increased the phagocytic ability of monocytes and reduced their ability to induce T cell proliferation and to expand Granzyme A+ CD8+ T cells. Our data suggest that despite the fact that helminth parasites and cancer cell lines are extraordinarily disparate, they share the ability to alter the phenotype of human monocytes.

  3. Similarities and differences between helminth parasites and cancer cell lines in shaping human monocytes: Insights into parallel mechanisms of immune evasion.

    Science.gov (United States)

    Narasimhan, Prakash Babu; Akabas, Leor; Tariq, Sameha; Huda, Naureen; Bennuru, Sasisekhar; Sabzevari, Helen; Hofmeister, Robert; Nutman, Thomas B; Tolouei Semnani, Roshanak

    2018-04-01

    A number of features at the host-parasite interface are reminiscent of those that are also observed at the host-tumor interface. Both cancer cells and parasites establish a tissue microenvironment that allows for immune evasion and may reflect functional alterations of various innate cells. Here, we investigated how the phenotype and function of human monocytes is altered by exposure to cancer cell lines and if these functional and phenotypic alterations parallel those induced by exposure to helminth parasites. Thus, human monocytes were exposed to three different cancer cell lines (breast, ovarian, or glioblastoma) or to live microfilariae (mf) of Brugia malayi-a causative agent of lymphatic filariasis. After 2 days of co-culture, monocytes exposed to cancer cell lines showed markedly upregulated expression of M1-associated (TNF-α, IL-1β), M2-associated (CCL13, CD206), Mreg-associated (IL-10, TGF-β), and angiogenesis associated (MMP9, VEGF) genes. Similar to cancer cell lines, but less dramatically, mf altered the mRNA expression of IL-1β, CCL13, TGM2 and MMP9. When surface expression of the inhibitory ligands PDL1 and PDL2 was assessed, monocytes exposed to both cancer cell lines and to live mf significantly upregulated PDL1 and PDL2 expression. In contrast to exposure to mf, exposure to cancer cell lines increased the phagocytic ability of monocytes and reduced their ability to induce T cell proliferation and to expand Granzyme A+ CD8+ T cells. Our data suggest that despite the fact that helminth parasites and cancer cell lines are extraordinarily disparate, they share the ability to alter the phenotype of human monocytes.

  4. Current and future state of FDA-CMS parallel reviews.

    Science.gov (United States)

    Messner, D A; Tunis, S R

    2012-03-01

    The US Food and Drug Administration (FDA) and the Centers for Medicare and Medicaid Services (CMS) recently proposed a partial alignment of their respective review processes for new medical products. The proposed "parallel review" not only offers an opportunity for some products to reach the market with Medicare coverage more quickly but may also create new incentives for product developers to conduct studies designed to address simultaneously the information needs of regulators, payers, patients, and clinicians.

  5. Semi-coarsening multigrid methods for parallel computing

    Energy Technology Data Exchange (ETDEWEB)

    Jones, J.E.

    1996-12-31

    Standard multigrid methods are not well suited for problems with anisotropic coefficients which can occur, for example, on grids that are stretched to resolve a boundary layer. There are several different modifications of the standard multigrid algorithm that yield efficient methods for anisotropic problems. In the paper, we investigate the parallel performance of these multigrid algorithms. Multigrid algorithms which work well for anisotropic problems are based on line relaxation and/or semi-coarsening. In semi-coarsening multigrid algorithms a grid is coarsened in only one of the coordinate directions unlike standard or full-coarsening multigrid algorithms where a grid is coarsened in each of the coordinate directions. When both semi-coarsening and line relaxation are used, the resulting multigrid algorithm is robust and automatic in that it requires no knowledge of the nature of the anisotropy. This is the basic multigrid algorithm whose parallel performance we investigate in the paper. The algorithm is currently being implemented on an IBM SP2 and its performance is being analyzed. In addition to looking at the parallel performance of the basic semi-coarsening algorithm, we present algorithmic modifications with potentially better parallel efficiency. One modification reduces the amount of computational work done in relaxation at the expense of using multiple coarse grids. This modification is also being implemented with the aim of comparing its performance to that of the basic semi-coarsening algorithm.

  6. Work-Efficient Parallel Skyline Computation for the GPU

    DEFF Research Database (Denmark)

    Bøgh, Kenneth Sejdenfaden; Chester, Sean; Assent, Ira

    2015-01-01

    offers the potential for parallelizing skyline computation across thousands of cores. However, attempts to port skyline algorithms to the GPU have prioritized throughput and failed to outperform sequential algorithms. In this paper, we introduce a new skyline algorithm, designed for the GPU, that uses...... a global, static partitioning scheme. With the partitioning, we can permit controlled branching to exploit transitive relationships and avoid most point-to-point comparisons. The result is a non-traditional GPU algorithm, SkyAlign, that prioritizes work-effciency and respectable throughput, rather than...

  7. Elastic Alignment of Microscopic Images Using Parallel Processing on CUDA-Supported Graphics Processor Units

    Czech Academy of Sciences Publication Activity Database

    Michálek, Jan; Čapek, M.; Janáček, Jiří; Kubínová, Lucie

    2010-01-01

    Roč. 16, Suppl.2 (2010), s. 730-731 ISSN 1431-9276. [Microscopy and Microanalysis 2010. Portland, 01.08.2010-05.08.2010] R&D Projects: GA ČR(CZ) GA102/08/0691; GA ČR(CZ) GA304/09/0733; GA MŠk(CZ) LC06063 Institutional research plan: CEZ:AV0Z50110509 Keywords : elastic alignment * CUDA * confocal microscopy Subject RIV: JD - Computer Applications, Robotics Impact factor: 2.179, year: 2010

  8. Xyce parallel electronic simulator : reference guide.

    Energy Technology Data Exchange (ETDEWEB)

    Mei, Ting; Rankin, Eric Lamont; Thornquist, Heidi K.; Santarelli, Keith R.; Fixel, Deborah A.; Coffey, Todd Stirling; Russo, Thomas V.; Schiek, Richard Louis; Warrender, Christina E.; Keiter, Eric Richard; Pawlowski, Roger Patrick

    2011-05-01

    This document is a reference guide to the Xyce Parallel Electronic Simulator, and is a companion document to the Xyce Users Guide. The focus of this document is (to the extent possible) exhaustively list device parameters, solver options, parser options, and other usage details of Xyce. This document is not intended to be a tutorial. Users who are new to circuit simulation are better served by the Xyce Users Guide. The Xyce Parallel Electronic Simulator has been written to support, in a rigorous manner, the simulation needs of the Sandia National Laboratories electrical designers. It is targeted specifically to run on large-scale parallel computing platforms but also runs well on a variety of architectures including single processor workstations. It also aims to support a variety of devices and models specific to Sandia needs. This document is intended to complement the Xyce Users Guide. It contains comprehensive, detailed information about a number of topics pertinent to the usage of Xyce. Included in this document is a netlist reference for the input-file commands and elements supported within Xyce; a command line reference, which describes the available command line arguments for Xyce; and quick-references for users of other circuit codes, such as Orcad's PSpice and Sandia's ChileSPICE.

  9. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez.

    Since June of 2009, the muon alignment group has focused on providing new alignment constants and on finalizing the hardware alignment reconstruction. Alignment constants for DTs and CSCs were provided for CRAFT09 data reprocessing. For DT chambers, the track-based alignment was repeated using CRAFT09 cosmic ray muons and validated using segment extrapolation and split cosmic tools. One difference with respect to the previous alignment is that only five degrees of freedom were aligned, leaving the rotation around the local x-axis to be better determined by the hardware system. Similarly, DT chambers poorly aligned by tracks (due to limited statistics) were aligned by a combination of photogrammetry and hardware-based alignment. For the CSC chambers, the hardware system provided alignment in global z and rotations about local x. Entire muon endcap rings were further corrected in the transverse plane (global x and y) by the track-based alignment. Single chamber track-based alignment suffers from poor statistic...

  10. Millimeter wave surface resistance of grain-aligned Y1Ba2Cu3O(x) bulk material

    Science.gov (United States)

    Wosik, J.; Kranenburg, R. A.; Wolfe, J. C.; Selvamanickam, V.; Salama, K.

    1991-01-01

    Measurements of the millimeter wave surface resistance of grain-aligned YBa2Cu3O(x) bulk material grown by a liquid phase process are reported. The measurements were performed by replacing the endplate of a TE011 cylindrical copper cavity with the superconducting sample. Surface resistance was measured for samples with surfaces oriented perpendicular and parallel to the c-axis of the grains. It is shown that, for the parallel configuration, the surface resistance at 77 K and 80 GHz is typically near 100 milliohms. For a very well-aligned sample with a very low density of Y2BaCuO(y) precipitates, measured in the perpendicular configuration, the transition width (10-90 percent) is about 2 K, and the surface resistance is less than 50 milliohms at 88 K. The effect of microstructure on surface resistance is discussed.

  11. Power-flow control and stability enhancement of four parallel-operated offshore wind farms using a line-commutated HVDC link

    DEFF Research Database (Denmark)

    Wang, Li; Wang, Kuo-Hua; Lee, Wei-Jen

    2010-01-01

    This paper presents an effective control scheme using a line-commutated high-voltage direct-current (HVDC) link with a designed rectifier current regulator (RCR) to simultaneously perform both power-fluctuation mitigation and damping improvement of four parallel-operated 80-MW offshore wind farms...... delivering generated power to a large utility grid. The proposed RCR of the HVDC link is designed by using modal control theory to contribute adequate damping to the studied four offshore wind farms under various wind speeds. A systematic analysis using a frequency-domain approach based on eigenvalue...... characteristics to the studied offshore wind farms under various wind speeds but also effectively mitigate power fluctuations of the offshore wind farms under wind-speed disturbance conditions....

  12. MPI_XSTAR: MPI-based Parallelization of the XSTAR Photoionization Program

    Science.gov (United States)

    Danehkar, Ashkbiz; Nowak, Michael A.; Lee, Julia C.; Smith, Randall K.

    2018-02-01

    We describe a program for the parallel implementation of multiple runs of XSTAR, a photoionization code that is used to predict the physical properties of an ionized gas from its emission and/or absorption lines. The parallelization program, called MPI_XSTAR, has been developed and implemented in the C++ language by using the Message Passing Interface (MPI) protocol, a conventional standard of parallel computing. We have benchmarked parallel multiprocessing executions of XSTAR, using MPI_XSTAR, against a serial execution of XSTAR, in terms of the parallelization speedup and the computing resource efficiency. Our experience indicates that the parallel execution runs significantly faster than the serial execution, however, the efficiency in terms of the computing resource usage decreases with increasing the number of processors used in the parallel computing.

  13. Comparing the Zeiss Callisto Eye and the Alcon Verion Image Guided System Toric Lens Alignment Technologies.

    Science.gov (United States)

    Hura, Arjan S; Osher, Robert H

    2017-07-01

    To compare the alignment meridian generated by the Zeiss Callisto Eye (Carl Zeiss AG, Dublin, CA) and the Alcon Verion Image Guided System (Alcon Laboratories, Inc., Fort Worth, TX). In this retrospective comparative evaluation of technology, intraoperative images were captured at different steps in the same surgery, allowing the comparison of the guidance lines generated by the Verion system to the parallel guidance lines generated by the Callisto Eye system. Measurements of each hemi-meridian were quantified using Adobe Photoshop 2015 CC software (Adobe Systems, San Jose, CA). The numbers of degrees separating these alignment meridians were calculated, entered into a database, and analyzed. The authors found that of 98 captured images of 16 eyes, the two technologies were identical in 0 eyes (θ 1 = θ 2 = 0), similar by 3° in 52 (53%) captured images (θ 1 ≠ θ 2 ≠ 0), and different by at least 3° in 46 (47%) captured images (θ 1 ≠ θ 2 ≠ 0). The target meridians were superimposed, the target lines were minimally separated, and the target lines were dissimilar. It was noted that some intraoperative variation occurred from measurement to measurement. Within the small group of 16 cases of routine toric lens implantation in this study, the absolute average number of degrees of misalignment between the Verion and Callisto Eye systems was 3.355 for θ 1 and 3.838 for θ 2 . On average, the intraoperative variation termed "drift" was noted to be 3.963° for θ 1 , and 4.557° for θ 2 . The authors found that small deviations were frequent when comparing two sophisticated technologies. Although deviations greater than 3° occurred in less than 47% of captured images from 16 eyes, smaller but significant variations of less than 3° occurred in 53% of captured images from 16 eyes. It was rare to identify a large deviation. However, the authors identified "drift" in the same eye when measurements were taken at different times. The results indicate that the two

  14. Bioinformatics algorithm based on a parallel implementation of a machine learning approach using transducers

    International Nuclear Information System (INIS)

    Roche-Lima, Abiel; Thulasiram, Ruppa K

    2012-01-01

    Finite automata, in which each transition is augmented with an output label in addition to the familiar input label, are considered finite-state transducers. Transducers have been used to analyze some fundamental issues in bioinformatics. Weighted finite-state transducers have been proposed to pairwise alignments of DNA and protein sequences; as well as to develop kernels for computational biology. Machine learning algorithms for conditional transducers have been implemented and used for DNA sequence analysis. Transducer learning algorithms are based on conditional probability computation. It is calculated by using techniques, such as pair-database creation, normalization (with Maximum-Likelihood normalization) and parameters optimization (with Expectation-Maximization - EM). These techniques are intrinsically costly for computation, even worse when are applied to bioinformatics, because the databases sizes are large. In this work, we describe a parallel implementation of an algorithm to learn conditional transducers using these techniques. The algorithm is oriented to bioinformatics applications, such as alignments, phylogenetic trees, and other genome evolution studies. Indeed, several experiences were developed using the parallel and sequential algorithm on Westgrid (specifically, on the Breeze cluster). As results, we obtain that our parallel algorithm is scalable, because execution times are reduced considerably when the data size parameter is increased. Another experience is developed by changing precision parameter. In this case, we obtain smaller execution times using the parallel algorithm. Finally, number of threads used to execute the parallel algorithm on the Breezy cluster is changed. In this last experience, we obtain as result that speedup is considerably increased when more threads are used; however there is a convergence for number of threads equal to or greater than 16.

  15. Scalable Parallel Methods for Analyzing Metagenomics Data at Extreme Scale

    Energy Technology Data Exchange (ETDEWEB)

    Daily, Jeffrey A. [Washington State Univ., Pullman, WA (United States)

    2015-05-01

    The field of bioinformatics and computational biology is currently experiencing a data revolution. The exciting prospect of making fundamental biological discoveries is fueling the rapid development and deployment of numerous cost-effective, high-throughput next-generation sequencing technologies. The result is that the DNA and protein sequence repositories are being bombarded with new sequence information. Databases are continuing to report a Moore’s law-like growth trajectory in their database sizes, roughly doubling every 18 months. In what seems to be a paradigm-shift, individual projects are now capable of generating billions of raw sequence data that need to be analyzed in the presence of already annotated sequence information. While it is clear that data-driven methods, such as sequencing homology detection, are becoming the mainstay in the field of computational life sciences, the algorithmic advancements essential for implementing complex data analytics at scale have mostly lagged behind. Sequence homology detection is central to a number of bioinformatics applications including genome sequencing and protein family characterization. Given millions of sequences, the goal is to identify all pairs of sequences that are highly similar (or “homologous”) on the basis of alignment criteria. While there are optimal alignment algorithms to compute pairwise homology, their deployment for large-scale is currently not feasible; instead, heuristic methods are used at the expense of quality. In this dissertation, we present the design and evaluation of a parallel implementation for conducting optimal homology detection on distributed memory supercomputers. Our approach uses a combination of techniques from asynchronous load balancing (viz. work stealing, dynamic task counters), data replication, and exact-matching filters to achieve homology detection at scale. Results for a collection of 2.56M sequences show parallel efficiencies of ~75-100% on up to 8K cores

  16. Scalable Parallel Methods for Analyzing Metagenomics Data at Extreme Scale

    International Nuclear Information System (INIS)

    Daily, Jeffrey A.

    2015-01-01

    The field of bioinformatics and computational biology is currently experiencing a data revolution. The exciting prospect of making fundamental biological discoveries is fueling the rapid development and deployment of numerous cost-effective, high-throughput next-generation sequencing technologies. The result is that the DNA and protein sequence repositories are being bombarded with new sequence information. Databases are continuing to report a Moore's law-like growth trajectory in their database sizes, roughly doubling every 18 months. In what seems to be a paradigm-shift, individual projects are now capable of generating billions of raw sequence data that need to be analyzed in the presence of already annotated sequence information. While it is clear that data-driven methods, such as sequencing homology detection, are becoming the mainstay in the field of computational life sciences, the algorithmic advancements essential for implementing complex data analytics at scale have mostly lagged behind. Sequence homology detection is central to a number of bioinformatics applications including genome sequencing and protein family characterization. Given millions of sequences, the goal is to identify all pairs of sequences that are highly similar (or 'homologous') on the basis of alignment criteria. While there are optimal alignment algorithms to compute pairwise homology, their deployment for large-scale is currently not feasible; instead, heuristic methods are used at the expense of quality. In this dissertation, we present the design and evaluation of a parallel implementation for conducting optimal homology detection on distributed memory supercomputers. Our approach uses a combination of techniques from asynchronous load balancing (viz. work stealing, dynamic task counters), data replication, and exact-matching filters to achieve homology detection at scale. Results for a collection of 2.56M sequences show parallel efficiencies of ~75-100% on up to 8K

  17. A 32-channel lattice transmission line array for parallel transmit and receive MRI at 7 tesla.

    Science.gov (United States)

    Adriany, Gregor; Auerbach, Edward J; Snyder, Carl J; Gözübüyük, Ark; Moeller, Steen; Ritter, Johannes; Van de Moortele, Pierre-François; Vaughan, Tommy; Uğurbil, Kâmil

    2010-06-01

    Transmit and receive RF coil arrays have proven to be particularly beneficial for ultra-high-field MR. Transmit coil arrays enable such techniques as B(1) (+) shimming to substantially improve transmit B(1) homogeneity compared to conventional volume coil designs, and receive coil arrays offer enhanced parallel imaging performance and SNR. Concentric coil arrangements hold promise for developing transceiver arrays incorporating large numbers of coil elements. At magnetic field strengths of 7 tesla and higher where the Larmor frequencies of interest can exceed 300 MHz, the coil array design must also overcome the problem of the coil conductor length approaching the RF wavelength. In this study, a novel concentric arrangement of resonance elements built from capacitively-shortened half-wavelength transmission lines is presented. This approach was utilized to construct an array with whole-brain coverage using 16 transceiver elements and 16 receive-only elements, resulting in a coil with a total of 16 transmit and 32 receive channels. (c) 2010 Wiley-Liss, Inc.

  18. SeqLib: a C ++ API for rapid BAM manipulation, sequence alignment and sequence assembly.

    Science.gov (United States)

    Wala, Jeremiah; Beroukhim, Rameen

    2017-03-01

    We present SeqLib, a C ++ API and command line tool that provides a rapid and user-friendly interface to BAM/SAM/CRAM files, global sequence alignment operations and sequence assembly. Four C libraries perform core operations in SeqLib: HTSlib for BAM access, BWA-MEM and BLAT for sequence alignment and Fermi for error correction and sequence assembly. Benchmarking indicates that SeqLib has lower CPU and memory requirements than leading C ++ sequence analysis APIs. We demonstrate an example of how minimal SeqLib code can extract, error-correct and assemble reads from a CRAM file and then align with BWA-MEM. SeqLib also provides additional capabilities, including chromosome-aware interval queries and read plotting. Command line tools are available for performing integrated error correction, micro-assemblies and alignment. SeqLib is available on Linux and OSX for the C ++98 standard and later at github.com/walaj/SeqLib. SeqLib is released under the Apache2 license. Additional capabilities for BLAT alignment are available under the BLAT license. jwala@broadinstitue.org ; rameen@broadinstitute.org. © The Author 2016. Published by Oxford University Press. All rights reserved. For Permissions, please e-mail: journals.permissions@oup.com

  19. Field emission from vertically aligned few-layer graphene

    International Nuclear Information System (INIS)

    Malesevic, Alexander; Kemps, Raymond; Vanhulsel, Annick; Chowdhury, Manish Pal; Volodin, Alexander; Van Haesendonck, Chris

    2008-01-01

    The electric field emission behavior of vertically aligned few-layer graphene was studied in a parallel plate-type setup. Few-layer graphene was synthesized in the absence of any metallic catalyst by microwave plasma enhanced chemical vapor deposition with gas mixtures of methane and hydrogen. The deposit consists of nanostructures that are several micrometers wide, highly crystalline stacks of four to six atomic layers of graphene, aligned vertically to the substrate surface in a high density network. The few-layer graphene is found to be a good field emitter, characterized by turn-on fields as low as 1 V/μm and field amplification factors up to several thousands. We observe a clear dependence of the few-layer graphene field emission behavior on the synthesis parameters: Hydrogen is identified as an efficient etchant to improve field emission, and samples grown on titanium show lower turn-on field values and higher amplification factors when compared to samples grown on silicon

  20. Inkjet printing of aligned single-walled carbon-nanotube thin films

    Science.gov (United States)

    Takagi, Yuki; Nobusa, Yuki; Gocho, Shota; Kudou, Hikaru; Yanagi, Kazuhiro; Kataura, Hiromichi; Takenobu, Taishi

    2013-04-01

    We report a method for the inkjet printing of aligned single-walled carbon-nanotube (SWCNT) films by combining inkjet technology with the strong wettability contrast between hydrophobic and hydrophilic areas based on the patterning of self-assembled monolayers. Both the drying process control using the strong wettability boundary and the coffee-stain effect strongly promote the aggregation of SWCNTs along the contact line of a SWCNT ink droplet, thereby demonstrating our achievement of inkjet-printed aligned SWCNT films. This method could open routes for developing high-performance and environmentally friendly SWCNT printed electronics.

  1. The hierarchical nature of the spin alignment of dark matter haloes in filaments

    Science.gov (United States)

    Aragon-Calvo, M. A.; Yang, Lin Forrest

    2014-05-01

    Dark matter haloes in cosmological filaments and walls have (in average) their spin vector aligned with their host structure. While haloes in walls are aligned with the plane of the wall independently of their mass, haloes in filaments present a mass-dependent two-regime orientation. Here, we show that the transition mass determining the change in the alignment regime (from parallel to perpendicular) depends on the hierarchical level in which the halo is located, reflecting the hierarchical nature of the Cosmic Web. By explicitly exposing the hierarchical structure of the Cosmic Web, we are able to identify the contributions of different components of the filament network to the alignment signal. We propose a unifying picture of angular momentum acquisition that is based on the results presented here and previous results found by other authors. In order to do a hierarchical characterization of the Cosmic Web, we introduce a new implementation of the multiscale morphology filter, the MMF-2, that significantly improves the identification of structures and explicitly describes their hierarchy. L36

  2. Formatt: Correcting protein multiple structural alignments by incorporating sequence alignment

    Directory of Open Access Journals (Sweden)

    Daniels Noah M

    2012-10-01

    Full Text Available Abstract Background The quality of multiple protein structure alignments are usually computed and assessed based on geometric functions of the coordinates of the backbone atoms from the protein chains. These purely geometric methods do not utilize directly protein sequence similarity, and in fact, determining the proper way to incorporate sequence similarity measures into the construction and assessment of protein multiple structure alignments has proved surprisingly difficult. Results We present Formatt, a multiple structure alignment based on the Matt purely geometric multiple structure alignment program, that also takes into account sequence similarity when constructing alignments. We show that Formatt outperforms Matt and other popular structure alignment programs on the popular HOMSTRAD benchmark. For the SABMark twilight zone benchmark set that captures more remote homology, Formatt and Matt outperform other programs; depending on choice of embedded sequence aligner, Formatt produces either better sequence and structural alignments with a smaller core size than Matt, or similarly sized alignments with better sequence similarity, for a small cost in average RMSD. Conclusions Considering sequence information as well as purely geometric information seems to improve quality of multiple structure alignments, though defining what constitutes the best alignment when sequence and structural measures would suggest different alignments remains a difficult open question.

  3. On-line learning from clustered input examples

    NARCIS (Netherlands)

    Riegler, Peter; Biehl, Michael; Solla, Sara A.; Marangi, Carmela; Marinaro, Maria; Tagliaferri, Roberto

    1996-01-01

    We analyse on-line learning of a linearly separable rule with a simple perceptron. Example inputs are taken from two overlapping clusters of data and the rule is defined through a teacher vector which is in general not aligned with the connection line of the cluster centers. We find that the Hebb

  4. A comparison of mandibular incisor proclination when using clear aligners and fixed labial orthodontic brackets

    OpenAIRE

    Hennessy, Joe

    2015-01-01

    The objective of this ‘2-arm parallel' clinical trial was to compare the mandibular incisor proclination produced by fixed labial appliances and 3rd generation clear aligners. TARA (Trinity’s Access to Research Archive) has a robust takedown policy. Please contact us if you have any concerns:

  5. The linear collider alignment and survey (LiCAS) project

    International Nuclear Information System (INIS)

    Bingham, Richard; Botcherby, Edward; Coe, Paul; Grzelak, Grzegorz; Mitra, Ankush; Reichold, Armin; Prenting, Johannes

    2003-01-01

    For the next generation of Linear Colliders (LC) the precision alignment of accelerator components will be critical. The DESY applied geodesy group has developed the concept of an automated 'survey train'. The train runs along the accelerator wall measuring the 3D position of a set of equispaced reference markers. This reference structure is then used to align the accelerator components. The LiCAS group is developing a measurement system for the survey train. It will use a combination of Laser Straightness Monitors (SM) and Frequency Scanning Interferometry (FSI). FSI is an interferometric length measurement technique originally developed for the online alignment of the ATLAS Inner Detector. This novel combination of optical techniques is expected to overcome the limitations of traditional open air survey. The authors describe the LiCAS project, the measurement systems and their integration into the survey train. The technical parameters and constraints will be mentioned. There will also be brief discussion of the second phase of the project to allow on-line monitoring of the LC alignment. (author)

  6. Multi-step lining-up correction of the CLIC trajectory

    CERN Document Server

    D'Amico, T E

    1999-01-01

    In the CLIC main linac it is very important to minimise the trajectory excursion and consequently the emittance dilution in order to obtain the required luminosity. Several algorithms have been proposed and lately the ballistic method has proved to be very effective. The trajectory correction method described hereafter retains the main advantages of the latter while adding some interesting features. It is based on the separation of the unknown variables like the quadrupole misalignments, the offset and slope of the injection straight line and the misalignments of the beam position monitors (BPM). This is achieved by referring the trajectory relatively to the injection line and not to the average pre-alignment line and by using two trajectories each corresponding to slightly different quadrupole strengths. A reference straight line is then derived onto which the beam is bent by a kick obtained by moving the first quadrupole. The other quadrupoles are then aligned on that line. The quality of the correction dep...

  7. The HIE-ISOLDE alignment and monitoring system software and test mock up

    CERN Document Server

    Kautzmann, G; Kadi, Y; Leclercq, Y; Waniorek, S; Williams, L

    2012-01-01

    For the HIE Isolde project a superconducting linac will be built at CERN in the Isolde facility area. The linac will be based on the creation and installation of 2 high- β and 4 low- β cryomodules containing respectively 5 high-β superconducting cavities and 1 superconducting solenoid for the two first ones, 6 low-β superconducting cavities and 2 superconducting solenoids for the four other ones. An alignment and monitoring system of the RF cavities and solenoids placed inside the cryomodules is needed to reach the optimum linac working conditions. The alignment system is based on opto-electronics, optics and precise mechanical instrumentation. The geometrical frame configuration, the data acquisition and the 3D adjustment will be managed using a dedicated software application. In parallel to the software development, an alignment system test mock-up has been built for software validation and dimensional tests. This paper will present the software concept and the development status, and then will describe...

  8. Comprehensive simulation study on local and global development of auroral arcs and field-aligned potentials

    International Nuclear Information System (INIS)

    Watanabe, Tomohiko; Oya, Hiroshi; Watanabe, Kunihiko; Sato, Tetsuya.

    1992-10-01

    Extensive three-dimensional computer simulations of the magnetosphere-ionosphere (M-I) coupling are performed to study self-excitation of auroral arcs with special emphasis on 1) nonlinear evolution of the feedback instability in the M-I coupling system, 2) controlling mechanisms of the auroral arc structure, 3) formation of a field-aligned electric potential structure in association with the development of the feedback instability, and 4) effects of the parallel potential generation on auroral arc development. It is reconfirmed that the feedback instability produces a longitudinally elongated, latitudinally striated structure where the upward field-aligned current and the ionospheric density are locally enhanced. The following important new features are revealed. 1) The global distribution of the striation structure is primarily governed by the magnetospheric convection pattern and the ionospheric density distribution. 2) There appears a significant dawn-dusk asymmetry in the auroral arc formation, even though the apparent geometrical relationship is symmetric. 3) The recombination effect plays a significant role in the global, as well as local, development of the auroral arc structure. The nonlinearity of recombination, in conjunction with the closure of an arc-associated local field-aligned current system, acts to destroy an old arc and creates a new arc in a different but adjacent position. 4) A V-shaped field aligned potential structure is created in association with an auroral arc. Rapid increase in the electron density and the local upward field-aligned current of an arc arises as a result of enhanced ionization by precipitating electrons accelerated by the parallel potential. 5) A drastic oscillatory behavior of appearance and disappearance of auroral arcs is obtained when the ionization effect is strong. The period is primarily given by the Alfven bounce time. (J.P.N.)

  9. Self-aligned blocking integration demonstration for critical sub-30nm pitch Mx level patterning with EUV self-aligned double patterning

    Science.gov (United States)

    Raley, Angélique; Lee, Joe; Smith, Jeffrey T.; Sun, Xinghua; Farrell, Richard A.; Shearer, Jeffrey; Xu, Yongan; Ko, Akiteru; Metz, Andrew W.; Biolsi, Peter; Devilliers, Anton; Arnold, John; Felix, Nelson

    2018-04-01

    We report a sub-30nm pitch self-aligned double patterning (SADP) integration scheme with EUV lithography coupled with self-aligned block technology (SAB) targeting the back end of line (BEOL) metal line patterning applications for logic nodes beyond 5nm. The integration demonstration is a validation of the scalability of a previously reported flow, which used 193nm immersion SADP targeting a 40nm pitch with the same material sets (Si3N4 mandrel, SiO2 spacer, Spin on carbon, spin on glass). The multi-color integration approach is successfully demonstrated and provides a valuable method to address overlay concerns and more generally edge placement error (EPE) as a whole for advanced process nodes. Unbiased LER/LWR analysis comparison between EUV SADP and 193nm immersion SADP shows that both integrations follow the same trend throughout the process steps. While EUV SADP shows increased LER after mandrel pull, metal hardmask open and dielectric etch compared to 193nm immersion SADP, the final process performance is matched in terms of LWR (1.08nm 3 sigma unbiased) and is only 6% higher than 193nm immersion SADP for average unbiased LER. Using EUV SADP enables almost doubling the line density while keeping most of the remaining processes and films unchanged, and provides a compelling alternative to other multipatterning integrations, which present their own sets of challenges.

  10. A Workflow to Improve the Alignment of Prostate Imaging with Whole-mount Histopathology.

    Science.gov (United States)

    Yamamoto, Hidekazu; Nir, Dror; Vyas, Lona; Chang, Richard T; Popert, Rick; Cahill, Declan; Challacombe, Ben; Dasgupta, Prokar; Chandra, Ashish

    2014-08-01

    Evaluation of prostate imaging tests against whole-mount histology specimens requires accurate alignment between radiologic and histologic data sets. Misalignment results in false-positive and -negative zones as assessed by imaging. We describe a workflow for three-dimensional alignment of prostate imaging data against whole-mount prostatectomy reference specimens and assess its performance against a standard workflow. Ethical approval was granted. Patients underwent motorized transrectal ultrasound (Prostate Histoscanning) to generate a three-dimensional image of the prostate before radical prostatectomy. The test workflow incorporated steps for axial alignment between imaging and histology, size adjustments following formalin fixation, and use of custom-made parallel cutters and digital caliper instruments. The control workflow comprised freehand cutting and assumed homogeneous block thicknesses at the same relative angles between pathology and imaging sections. Thirty radical prostatectomy specimens were histologically and radiologically processed, either by an alignment-optimized workflow (n = 20) or a control workflow (n = 10). The optimized workflow generated tissue blocks of heterogeneous thicknesses but with no significant drifting in the cutting plane. The control workflow resulted in significantly nonparallel blocks, accurately matching only one out of four histology blocks to their respective imaging data. The image-to-histology alignment accuracy was 20% greater in the optimized workflow (P alignment was observed in the optimized workflow. Evaluation of prostate imaging biomarkers using whole-mount histology references should include a test-to-reference spatial alignment workflow. Copyright © 2014 AUR. Published by Elsevier Inc. All rights reserved.

  11. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez

    2010-01-01

    The main developments in muon alignment since March 2010 have been the production, approval and deployment of alignment constants for the ICHEP data reprocessing. In the barrel, a new geometry, combining information from both hardware and track-based alignment systems, has been developed for the first time. The hardware alignment provides an initial DT geometry, which is then anchored as a rigid solid, using the link alignment system, to a reference frame common to the tracker. The “GlobalPositionRecords” for both the Tracker and Muon systems are being used for the first time, and the initial tracker-muon relative positioning, based on the link alignment, yields good results within the photogrammetry uncertainties of the Tracker and alignment ring positions. For the first time, the optical and track-based alignments show good agreement between them; the optical alignment being refined by the track-based alignment. The resulting geometry is the most complete to date, aligning all 250 DTs, ...

  12. Parallel heat transport in integrable and chaotic magnetic fields

    Energy Technology Data Exchange (ETDEWEB)

    Castillo-Negrete, D. del; Chacon, L. [Oak Ridge National Laboratory, Oak Ridge, Tennessee 37831-8071 (United States)

    2012-05-15

    The study of transport in magnetized plasmas is a problem of fundamental interest in controlled fusion, space plasmas, and astrophysics research. Three issues make this problem particularly challenging: (i) The extreme anisotropy between the parallel (i.e., along the magnetic field), {chi}{sub ||} , and the perpendicular, {chi}{sub Up-Tack }, conductivities ({chi}{sub ||} /{chi}{sub Up-Tack} may exceed 10{sup 10} in fusion plasmas); (ii) Nonlocal parallel transport in the limit of small collisionality; and (iii) Magnetic field lines chaos which in general complicates (and may preclude) the construction of magnetic field line coordinates. Motivated by these issues, we present a Lagrangian Green's function method to solve the local and non-local parallel transport equation applicable to integrable and chaotic magnetic fields in arbitrary geometry. The method avoids by construction the numerical pollution issues of grid-based algorithms. The potential of the approach is demonstrated with nontrivial applications to integrable (magnetic island), weakly chaotic (Devil's staircase), and fully chaotic magnetic field configurations. For the latter, numerical solutions of the parallel heat transport equation show that the effective radial transport, with local and non-local parallel closures, is non-diffusive, thus casting doubts on the applicability of quasilinear diffusion descriptions. General conditions for the existence of non-diffusive, multivalued flux-gradient relations in the temperature evolution are derived.

  13. Crystallization Behavior of Poly(ethylene oxide) in Vertically Aligned Carbon Nanotube Array.

    Science.gov (United States)

    Sheng, Jiadong; Zhou, Shenglin; Yang, Zhaohui; Zhang, Xiaohua

    2018-03-27

    We investigate the effect of the presence of vertically aligned multiwalled carbon nanotubes (CNTs) on the orientation of poly(ethylene oxide) (PEO) lamellae and PEO crystallinity. The high alignment of carbon nanotubes acting as templates probably governs the orientation of PEO lamellae. This templating effect might result in the lamella planes of PEO crystals oriented along a direction parallel to the long axis of the nanotubes. The presence of aligned carbon nanotubes also gives rise to the decreases in PEO crystallinity, crystallization temperature, and melting temperature due to the perturbation of carbon nanotubes to the crystallization of PEO. These effects have significant implications for controlling the orientation of PEO lamellae and decreasing the crystallinity of PEO and thickness of PEO lamellae, which have significant impacts on ion transport in PEO/CNT composite and the capacitive performance of PEO/CNT composite. Both the decreased PEO crystallinity and the orientation of PEO lamellae along the long axes of vertically aligned CNTs give rise to the decrease in the charge transfer resistance, which is associated with the improvements in the ion transport and capacitive performance of PEO/CNT composite.

  14. Massive ordering and alignment of cylindrical micro-objects by photovoltaic optoelectronic tweezers.

    Science.gov (United States)

    Elvira, Iris; Muñoz-Martínez, Juan F; Barroso, Álvaro; Denz, Cornelia; Ramiro, José B; García-Cabañes, Angel; Agulló-López, Fernando; Carrascosa, Mercedes

    2018-01-01

    Optical tools for manipulation and trapping of micro- and nano-objects are a fundamental issue for many applications in nano- and biotechnology. This work reports on the use of one such method, known as photovoltaic optoelectronics tweezers, to orientate and organize cylindrical microcrystals, specifically elongated zeolite L, on the surface of Fe-doped LiNbO 3 crystal plates. Patterns of aligned zeolites have been achieved through the forces and torques generated by the bulk photovoltaic effect. The alignment patterns with zeolites parallel or perpendicular to the substrate surface are highly dependent on the features of light distribution and crystal configuration. Moreover, dielectrophoretic chains of zeolites with lengths up to 100 μm have often been observed. The experimental results of zeolite trapping and alignment have been discussed and compared together with theoretical simulations of the evanescent photovoltaic electric field and the dielectrophoretic potential. They demonstrate the remarkable capabilities of the optoelectronic photovoltaic method to orientate and pattern anisotropic microcrystals. The combined action of patterning and alignment offers a unique tool to prepare functional nanostructures with potential applications in a variety of fields such as nonlinear optics or plasmonics.

  15. Photodissociation of spatially aligned acetaldehyde cations.

    Science.gov (United States)

    Lee, Suk Kyoung; Silva, Ruchira; Kim, Myung Hwa; Shen, Lei; Suits, Arthur G

    2007-07-26

    Photofragment translational energy and angular distributions are reported for the photodissociation of acetaldehyde cations in the wavelength range 354-363 nm obtained using the DC slice ion imaging technique. Vibrationally selected parent ions were produced by 2+1 resonance-enhanced multiphoton ionization (REMPI) via the 3sCH3CO+, and CH4+. The angular distributions reveal that all product channels have a predominantly parallel recoil anisotropy although the lower beta2 parameter of CH3CO+ indicates the concomitant presence of a perpendicular component. Furthermore, the distinct angular distribution of the CH3CO+ fragments shows a large value of the higher order Legendre polynomial term, providing evidence that acetaldehyde cations are spatially aligned during the ionization process.

  16. Mammalian cortical astrocytes align themselves in a physiological voltage gradient.

    Science.gov (United States)

    Borgens, R B; Shi, R; Mohr, T J; Jaeger, C B

    1994-07-01

    Astrocytes obtained from primary cultures of newborn rat cerebral cortex show a marked structural rearrangement to weak (50-500 mV/mm) applied voltage gradients. Astrocytes reorient their processes so that the cells are aligned perpendicular to the voltage gradient. At field strengths of 100 mV/mm or greater, this realignment occurs in over 90% of the cell population. Furthermore, these magnitudes of electric fields completely eliminate any parallel alignments originally observed prior to application of the voltage. Realignment usually occurs by a withdrawal, followed by an extension, of cell processes. These responses occur at voltage gradients within the physiological range that naturally exist across the neural tube during early development. We suggest the possibility that architectural arrangements of developing glia and, subsequently, neurons may be regulated by endogenous transepithelial potentials that exist across embryonic neuroepithelium.

  17. Series Transmission Line Transformer

    Science.gov (United States)

    Buckles, Robert A.; Booth, Rex; Yen, Boris T.

    2004-06-29

    A series transmission line transformer is set forth which includes two or more of impedance matched sets of at least two transmissions lines such as shielded cables, connected in parallel at one end ans series at the other in a cascading fashion. The cables are wound about a magnetic core. The series transmission line transformer (STLT) which can provide for higher impedance ratios and bandwidths, which is scalable, and which is of simpler design and construction.

  18. VERY STRONG EMISSION-LINE GALAXIES IN THE WFC3 INFRARED SPECTROSCOPIC PARALLEL SURVEY AND IMPLICATIONS FOR HIGH-REDSHIFT GALAXIES

    Energy Technology Data Exchange (ETDEWEB)

    Atek, H.; Colbert, J.; Shim, H. [Spitzer Science Center, Caltech, Pasadena, CA 91125 (United States); Siana, B.; Bridge, C. [Department of Astronomy, Caltech, Pasadena, CA 91125 (United States); Scarlata, C. [Department of Astronomy, University of Minnesota-Twin Cities, Minneapolis, MN 55455 (United States); Malkan, M.; Ross, N. R. [Department of Physics and Astronomy, University of California, Los Angeles, CA (United States); McCarthy, P.; Dressler, A.; Hathi, N. P. [Observatories of the Carnegie Institution for Science, Pasadena, CA 91101 (United States); Teplitz, H. [Infrared Processing and Analysis Center, Caltech, Pasadena, CA 91125 (United States); Henry, A.; Martin, C. [Department of Physics, University of California, Santa Barbara, CA 93106 (United States); Bunker, A. J. [Department of Physics, University of Oxford, Denys Wilkinson Building, Keble Road, Oxford OX1 3RH (United Kingdom); Fosbury, R. A. E. [Space Telescope-European Coordinating Facility, Garching bei Muenchen (Germany)

    2011-12-20

    The WFC3 Infrared Spectroscopic Parallel Survey uses the Hubble Space Telescope (HST) infrared grism capabilities to obtain slitless spectra of thousands of galaxies over a wide redshift range including the peak of star formation history of the universe. We select a population of very strong emission-line galaxies with rest-frame equivalent widths (EWs) higher than 200 A. A total of 176 objects are found over the redshift range 0.35 < z < 2.3 in the 180 arcmin{sup 2} area that we have analyzed so far. This population consists of young and low-mass starbursts with high specific star formation rates (sSFR). After spectroscopic follow-up of one of these galaxies with Keck/Low Resolution Imaging Spectrometer, we report the detection at z = 0.7 of an extremely metal-poor galaxy with 12 + log(O/H) =7.47 {+-} 0.11. After estimating the active galactic nucleus fraction in the sample, we show that the high-EW galaxies have higher sSFR than normal star-forming galaxies at any redshift. We find that the nebular emission lines can substantially affect the total broadband flux density with a median brightening of 0.3 mag, with some examples of line contamination producing brightening of up to 1 mag. We show that the presence of strong emission lines in low-z galaxies can mimic the color-selection criteria used in the z {approx} 8 dropout surveys. In order to effectively remove low-redshift interlopers, deep optical imaging is needed, at least 1 mag deeper than the bands in which the objects are detected. Without deep optical data, most of the interlopers cannot be ruled out in the wide shallow HST imaging surveys. Finally, we empirically demonstrate that strong nebular lines can lead to an overestimation of the mass and the age of galaxies derived from fitting of their spectral energy distribution (SED). Without removing emission lines, the age and the stellar mass estimates are overestimated by a factor of 2 on average and up to a factor of 10 for the high-EW galaxies

  19. A position sensitive parallel plate avalanche counter

    International Nuclear Information System (INIS)

    Lombardi, M.; Tan Jilian; Potenza, R.; D'amico, V.

    1986-01-01

    A position sensitive parallel plate avalanche counter with a distributed constant delay-line-cathode (PSAC) is described. The strips formed on the printed board were served as the cathode and the delay line for readout of signals. The detector (PSAC) was operated in isobutane gas at the pressure range from 10 to 20 torr. The position resolution is better than 1 mm and the time resolution is about 350 ps, for 252 Cf fission-spectrum source

  20. Simulation Exploration through Immersive Parallel Planes

    Energy Technology Data Exchange (ETDEWEB)

    Brunhart-Lupo, Nicholas J [National Renewable Energy Laboratory (NREL), Golden, CO (United States); Bush, Brian W [National Renewable Energy Laboratory (NREL), Golden, CO (United States); Gruchalla, Kenny M [National Renewable Energy Laboratory (NREL), Golden, CO (United States); Smith, Steve [Los Alamos Visualization Associates

    2017-05-25

    We present a visualization-driven simulation system that tightly couples systems dynamics simulations with an immersive virtual environment to allow analysts to rapidly develop and test hypotheses in a high-dimensional parameter space. To accomplish this, we generalize the two-dimensional parallel-coordinates statistical graphic as an immersive 'parallel-planes' visualization for multivariate time series emitted by simulations running in parallel with the visualization. In contrast to traditional parallel coordinate's mapping the multivariate dimensions onto coordinate axes represented by a series of parallel lines, we map pairs of the multivariate dimensions onto a series of parallel rectangles. As in the case of parallel coordinates, each individual observation in the dataset is mapped to a polyline whose vertices coincide with its coordinate values. Regions of the rectangles can be 'brushed' to highlight and select observations of interest: a 'slider' control allows the user to filter the observations by their time coordinate. In an immersive virtual environment, users interact with the parallel planes using a joystick that can select regions on the planes, manipulate selection, and filter time. The brushing and selection actions are used to both explore existing data as well as to launch additional simulations corresponding to the visually selected portions of the input parameter space. As soon as the new simulations complete, their resulting observations are displayed in the virtual environment. This tight feedback loop between simulation and immersive analytics accelerates users' realization of insights about the simulation and its output.

  1. Aptaligner: automated software for aligning pseudorandom DNA X-aptamers from next-generation sequencing data.

    Science.gov (United States)

    Lu, Emily; Elizondo-Riojas, Miguel-Angel; Chang, Jeffrey T; Volk, David E

    2014-06-10

    Next-generation sequencing results from bead-based aptamer libraries have demonstrated that traditional DNA/RNA alignment software is insufficient. This is particularly true for X-aptamers containing specialty bases (W, X, Y, Z, ...) that are identified by special encoding. Thus, we sought an automated program that uses the inherent design scheme of bead-based X-aptamers to create a hypothetical reference library and Markov modeling techniques to provide improved alignments. Aptaligner provides this feature as well as length error and noise level cutoff features, is parallelized to run on multiple central processing units (cores), and sorts sequences from a single chip into projects and subprojects.

  2. HIE ISOLDE Alignment and monitoring system technical design and project status

    CERN Document Server

    Gayde, J C; Kautzmann, G; Leclercq, Y; Waniorek, S; Williams, L

    2012-01-01

    In the frame of the HIE ISOLDE project most of the existing ISOLDE REX line will be replaced by a superconducting linac in order to upgrade the energy and intensity of the REX ISOLDE facility at CERN. Beam-physics simulations show that the optimum linac working conditions are obtained when the main axes of the active components, RF cavities and solenoid placed inside the cryostats, are aligned and permanently monitored on the REX Nominal Beam Line (NBL) within a precision of 0.3 mm for the cavities and 0.15 mm for the solenoids at one sigma level along directions perpendicular to the beam axis. This paper presents the proposed adjustment and alignment system based on opto-electronic sensors, optics and precise mechanic elements which are used, for some of them, in various non-standard environmental conditions such as high vacuum, cryogenic temperatures.

  3. Metrology and Alignment of Light Weight Grazing Incidence X-Ray Mirrors

    Science.gov (United States)

    Zhang, William; Content, David; Petre, Robert; Saha, Timo

    2000-01-01

    Metrology and alignment of light weight X-ray optics have been a challenge for two reasons: (1) that the intrinsic mirror quality and distortions caused by handling can not be easily separated, and (2) the diffraction limits of the visible light become a severe problem at the order of one arc-minute. Traditional methods of using a normal incident pencil or small parallel beam which monitors a tiny fraction of the mirror in question at a given time can not adequately monitor those distortions. We are developing a normal incidence setup that monitors a large fraction, if not the whole, of the mirror at any given time. It will allow us to align thin X-ray mirrors to-an accuracy of a few arc seconds or to a limit dominated by the mirror intrinsic quality.

  4. Track based alignment of the Mu3e detector

    Energy Technology Data Exchange (ETDEWEB)

    Hartenstein, Ulrich [Institut fuer Kernphysik, Universitaet Mainz (Germany)

    2016-07-01

    The Mu3e experiment searches for the lepton flavor violating decay μ{sup +} → e{sup +}e{sup -}e{sup +} with a sensitivity goal for the branching fraction of better than 10{sup -16}. This process is heavily supressed in the standard model of particle physics (BR < 10{sup -50}) which makes an observation of this decay a clear indication of new physics. For track reconstruction, four barrel shaped layers consisting of about 3000 high-voltage monolithic active pixel sensors (HV-MAPS) are used. The position, orientation and possible deformations of these sensors must be known to greater precision than the assembly tolerances. A track based alignment via the General Broken Lines fit and the Millepede-II algorithm will be used to achieve this precision in the final detector. The talk discusses a study of the required alignment precision and preparations for aligning the detector using a detailed simulation.

  5. AC dielectrophoresis alignment of single-walled carbon nano tubes (SWNTS) and palladium nano wires for hydrogen gas sensor

    International Nuclear Information System (INIS)

    Nur Ubaidah Saidin; Nur Ubaidah Saidin; Ying, K.K.; KKhuan, N.I.; Mohammad Hafizuddin Jumali

    2013-01-01

    Full-text: Using AC electric field, nano wires or nano tubes can be aligned, chained or accelerated in a direction parallel to the applied field, oriented or concentrated onto designated locations as well as dispersed in controlled manner under high efficiencies. In this work, systematic study on the alignment of nano wires/ nano tubes across the 3 μm-gaps between pairs of micro fabricated gold electrodes was carried out using AC dielectrophoresis technique. Densities and alignment of the nano wires/ nano tubes across the gaps of the electrodes were controlled by the applied AC field strengths and frequencies on the electrodes. Good alignments of SWNTs and Pd nano wires were achieved at an applied frequency of 5 MHz and a field strength as high as 25 V pp for Pd nano wires compared to only 2 V pp for SWNTs. The aligned nano wires/ nano tubes will be functioned as sensor elements for hydrogen gas sensing. (author)

  6. Setup error in radiotherapy: on-line correction using electronic kilovoltage and megavoltage radiographs

    International Nuclear Information System (INIS)

    Pisani, Laura; Lockman, David; Jaffray, David; Yan Di; Martinez, Alvaro; Wong, John

    2000-01-01

    Purpose: We hypothesize that the difference in image quality between the traditional kilovoltage (kV) prescription radiographs and megavoltage (MV) treatment radiographs is a major factor hindering our ability to accurately measure, thus correct, setup error in radiation therapy. The objective of this work is to study the accuracy of on-line correction of setup errors achievable using either kV- or MV-localization (i.e., open-field) radiographs. Methods and Materials: Using a gantry mounted kV and MV dual-beam imaging system, the accuracy of on-line measurement and correction of setup error using electronic kV- and MV-localization images was examined based on anthropomorphic phantom and patient imaging studies. For the phantom study, the user's ability to accurately detect known translational shifts was analyzed. The clinical study included 14 patients with disease in the head and neck, thoracic, and pelvic regions. For each patient, 4 orthogonal kV radiographs acquired during treatment simulation from the right lateral, anterior-to-posterior, left lateral, and posterior-to-anterior directions were employed as reference prescription images. Two-dimensional (2D) anatomic templates were defined on each of the 4 reference images. On each treatment day, after positioning the patient for treatment, 4 orthogonal electronic localization images were acquired with both kV and 6-MV photon beams. On alternate weeks, setup errors were determined from either the kV- or MV-localization images but not both. Setup error was determined by aligning each 2D template with the anatomic information on the corresponding localization image, ignoring rotational and nonrigid variations. For each set of 4 orthogonal images, the results from template alignments were averaged. Based on the results from the phantom study and a parallel study of the inter- and intraobserver template alignment variability, a threshold for minimum correction was set at 2 mm in any direction. Setup correction was

  7. Can primordial magnetic fields seeded by electroweak strings cause an alignment of quasar axes on cosmological scales?

    Science.gov (United States)

    Poltis, Robert; Stojkovic, Dejan

    2010-10-15

    The decay of nontopological electroweak strings may leave an observable imprint in the Universe today in the form of primordial magnetic fields. Protogalaxies preferentially tend to form with their axis of rotation parallel to an external magnetic field, and, moreover, an external magnetic field produces torque which tends to align the galaxy axis with the magnetic field. We demonstrate that the shape of a magnetic field left over from two looped electroweak strings can explain the observed nontrivial alignment of quasar polarization vectors and make predictions for future observations.

  8. Enhanced pyroelectric and piezoelectric properties of PZT with aligned porosity for energy harvesting applications† †Electronic supplementary information (ESI) available. See DOI: 10.1039/c7ta00967d Click here for additional data file.

    Science.gov (United States)

    Zhang, Yan; Xie, Mengying; Roscow, James; Bao, Yinxiang; Zhou, Kechao

    2017-01-01

    This paper demonstrates the significant benefits of exploiting highly aligned porosity in piezoelectric and pyroelectric materials for improved energy harvesting performance. Porous lead zirconate (PZT) ceramics with aligned pore channels and varying fractions of porosity were manufactured in a water-based suspension using freeze-casting. The aligned porous PZT ceramics were characterized in detail for both piezoelectric and pyroelectric properties and their energy harvesting performance figures of merit were assessed parallel and perpendicular to the freezing direction. As a result of the introduction of porosity into the ceramic microstructure, high piezoelectric and pyroelectric harvesting figures of merits were achieved for porous freeze-cast PZT compared to dense PZT due to the reduced permittivity and volume specific heat capacity. Experimental results were compared to parallel and series analytical models with good agreement and the PZT with porosity aligned parallel to the freezing direction exhibited the highest piezoelectric and pyroelectric harvesting response; this was a result of the enhanced interconnectivity of the ferroelectric material along the poling direction and reduced fraction of unpoled material that leads to a higher polarization. A complete thermal energy harvesting system, composed of a parallel-aligned PZT harvester element and an AC/DC converter, was successfully demonstrated by charging a storage capacitor. The maximum energy density generated by the 60 vol% porous parallel-connected PZT when subjected to thermal oscillations was 1653 μJ cm–3, which was 374% higher than that of the dense PZT with an energy density of 446 μJ cm–3. The results are beneficial for the design and manufacture of high performance porous pyroelectric and piezoelectric materials in devices for energy harvesting and sensor applications. PMID:28580142

  9. Generation of macroscopic magnetic-field-aligned electric fields by the convection surge ion acceleratiom mechanism

    International Nuclear Information System (INIS)

    Mauk, B.H.

    1989-01-01

    The ''convection surge'' computer model presented previously (concerning the dramatic, nonadiabatic, magnetic-field-aligned energization of ions near the Earth's geosynchronous orbit in the presence of strong, transient, magnetic-field-perpendicular inductive electric fields) has been extended to include the self-consistent generation of magnetic-field-aligned electric fields. The field-aligned electric potential is obtained by imposing the quasi-neutrality condition using approximated electron distribution forms. The ions are forced to respond self-consistently to this potential. It is found that field-aligned potential drops up to 1 to 10 kV can be generated depending on electron temperatures and on the mass species of the ions. During transient periods of the process, these large potential drops can be confined to a few degrees of magnetic latitude at positions close to the magnetic equator. Anomalous, sometimes dramatic, additional magnetic-field-aligned ion acceleration also occurs in part as a result of a quasi-resonance between the parallel velocities of some ions and the propagating electric potential fronts. It is speculated that the convection surge mechanism could be a key player in the transient, field-aligned electromagnetic processes observed to operate within the middle (e.g., geosynchronous) magnetosphere. copyright American Geophysical Union 1989

  10. Do quasar ley lines really exist

    International Nuclear Information System (INIS)

    Webster, A.

    1982-01-01

    The hypothesis that the distribution of the quasars on the celestial sphere contains an unexpectedly large number of well-aligned triples is tested by applying, to the Cerro Tololo objective-prism sample, a shape-statistic which was originally developed to investigate whether neolithic standing stones were deliberately sited on ley lines. It is found that alignment in triples is not a conspicuous feature of the quasars in this sample. The sample does contain one well aligned triple whose properties resemble those of two triples found earlier in a different field by earlier authors, but the probability of this being a chance alignment is not low. The same authors have noted a total of four well-collimated triples which they consider remarkable, but an approximate probability calculation based on the shape-statistic indicates that they need not have a low probability of occurring by chance. (author)

  11. Slit shaped microwave induced atmospheric pressure plasma based on a parallel plate transmission line resonator

    Science.gov (United States)

    Kang, S. K.; Seo, Y. S.; Lee, H. Wk; Aman-ur-Rehman; Kim, G. C.; Lee, J. K.

    2011-11-01

    A new type of microwave-excited atmospheric pressure plasma source, based on the principle of parallel plate transmission line resonator, is developed for the treatment of large areas in biomedical applications such as skin treatment and wound healing. A stable plasma of 20 mm width is sustained by a small microwave power source operated at a frequency of 700 MHz and a gas flow rate of 0.9 slm. Plasma impedance and plasma density of this plasma source are estimated by fitting the calculated reflection coefficient to the measured one. The estimated plasma impedance shows a decreasing trend while estimated plasma density shows an increasing trend with the increase in the input power. Plasma uniformity is confirmed by temperature and optical emission distribution measurements. Plasma temperature is sustained at less than 40 °C and abundant amounts of reactive species, which are important agents for bacteria inactivation, are detected over the entire plasma region. Large area treatment ability of this newly developed device is verified through bacteria inactivation experiment using E. coli. Sterilization experiment shows a large bacterial killing mark of 25 mm for a plasma treatment time of 10 s.

  12. Electric alignment of plate shaped clay aggregates in oils

    Science.gov (United States)

    Castberg, Rene; Rozynek, Zbigniew; Måløy, Knut Jørgen; Flekkøy, Eirik

    2016-01-01

    We experimentally investigate the rotation of plate shaped aggregates of clay mineral particles immersed in silicone oil. The rotation is induced by an external electric field. The rotation time is measured as a function of the following parameters: electric field strength, the plate geometry (length and width) and the dielectric properties of the plates. We find that the plates always align with their longest axis parallel to the direction of the electric field (E), independently of the arrangement of individual clay -2 mineral particles within the plate. The rotation time is found to scale as E and is proportional to the viscosity (μ), which coincides well with a model that describes orientation of dipoles in electric fields. As the length of the plate is increased we quantify a difference between the longitudinal and transverse polarisability. Finally, we show that moist plates align faster. We attribute this to the change of the dielectric properties of the plate due to the presence of water.

  13. Electric alignment of plate shaped clay aggregates in oils

    Directory of Open Access Journals (Sweden)

    Rene Christian Castberg

    2016-01-01

    Full Text Available We experimentally investigate the rotation of plate shaped aggregates of clay mineral particles immersed in silicone oil. The rotation is induced by an external electric field. The rotation time is measured as a function of the following parameters: electric field strength, the plate geometry (length and width and the dielectric properties of the plates. We find that the plates always align with their longest axis parallel to the direction of the electric field (E, independently of the arrangement of individual clay−2 mineral particles within the plate. The rotation time is found to scale as E and is proportional to the viscosity (μ, which coincides well with a model that describes orientation of dipoles in electric fields. As the length of the plate is increased we quantify a difference between the longitudinal and transverse polarisability. Finally, we show that moist plates align faster. We attribute this to the change of the dielectric properties of the plate due to the presence of water.

  14. Measurement of the attosecond emission from aligned molecules

    International Nuclear Information System (INIS)

    Boutu, W.; Merdji, H.; Fitour, R.; Monchicourt, P.; Breger, P.; Carre, B.; Salieres, P.

    2006-01-01

    Complete test of publication follows. Recently, a number of papers have demonstrated the interest of high-order harmonic generation (HHG) from molecules aligned with respect to the laser polarization. Itatani et al. (Nature 432, 867 (2004)) have shown that a precise characterization of the harmonic emission allows performing a tomographic reconstruction of the molecular orbitals that radiate. Kanai et al. (Nature 435, 470 (2005)) have evidenced quantum interferences in the recombination process of HHG that are directly related to the molecular structure. In all of these papers, only the HHG intensity was measured. The relative harmonic phase, though more difficult to measure, contains important information on the interference process, and is needed for an ab initio tomographic reconstruction. Finally, while the attosecond emission from atoms has been thoroughly studied, in particular by our group (Mairesse et al., Science (302, 1540 (2003)), it has not been investigated in molecules. In a first experiment (Wabnitz et al., EPJD (2006)), we measured the amplitude and relative phase of harmonics radiated by un-aligned nitrogen molecules. Small but reproducible deviations from the phase of harmonics generated in argon (same ionization potential as nitrogen) were measured for low orders. In a recent experiment, we have measured, up to high order, the harmonic amplitude and relative phase for aligned molecules (N 2 and CO 2 ). In order to align the molecules, we used the so-called nonadiabatic technique: a rotational wavepacket is created by a strong enough and short aligning pulse, so that a field-free alignment is obtained at the revival (a few ps after the aligning pulse). The measurement of phase locking between neighboring harmonics was performed through the photoionization of a target gas by the harmonic beam in presence of a sufficiently intense 'dressing' laser beam (RABITT technique). The harmonic phase measured when the CO 2 molecules are aligned parallel to

  15. H(+) - O(+) two-stream interaction on auroral field lines

    International Nuclear Information System (INIS)

    Bergmann, R.

    1990-01-01

    Upflowing beams of hydrogen, oxygen, and minor ion species, and downward accelerated electrons have been observed above several thousand kilometers altitude on evening auroral field lines. The mechanism for electron and ion acceleration is generally accepted to be the presence of a quasi-static electric field with a component parallel to the earth's magnetic field. The thermal energy of the observed beams is much larger than ionospheric ion temperatures indicating that the beams have been heated as they are accelerated upward. This heating is probably due to a two-stream interaction between beams of different mass ions. The beams gain equal energy in the potential drop and so have different average velocities. Their relative streaming initiates an ion-ion two-stream interaction which then mediates a transfer of energy and momentum between the beams and causes thermalization of each beam. The qualitative evidence that supports this scenario is reviewed. Properties of the two-stream instability are presented in order to demonstrate that a calculation of the evolution of ion beams requires a model that includes field-aligned spatial structure. 26 refs

  16. PACMAN Project: A New Solution for the High-accuracy Alignment of Accelerator Components

    CERN Document Server

    Mainaud Durand, Helene; Buzio, Marco; Caiazza, Domenico; Catalán Lasheras, Nuria; Cherif, Ahmed; Doytchinov, Iordan; Fuchs, Jean-Frederic; Gaddi, Andrea; Galindo Munoz, Natalia; Gayde, Jean-Christophe; Kamugasa, Solomon; Modena, Michele; Novotny, Peter; Russenschuck, Stephan; Sanz, Claude; Severino, Giordana; Tshilumba, David; Vlachakis, Vasileios; Wendt, Manfred; Zorzetti, Silvia

    2016-01-01

    The beam alignment requirements for the next generation of lepton colliders have become increasingly challenging. As an example, the alignment requirements for the three major collider components of the CLIC linear collider are as follows. Before the first beam circulates, the Beam Position Monitors (BPM), Accelerating Structures (AS)and quadrupoles will have to be aligned up to 10 μm w.r.t. a straight line over 200 m long segments, along the 20 km of linacs. PACMAN is a study on Particle Accelerator Components' Metrology and Alignment to the Nanometre scale. It is an Innovative Doctoral Program, funded by the EU and hosted by CERN, providing high quality training to 10 Early Stage Researchers working towards a PhD thesis. The technical aim of the project is to improve the alignment accuracy of the CLIC components by developing new methods and tools addressing several steps of alignment simultaneously, to gain time and accuracy. The tools and methods developed will be validated on a test bench. This paper pr...

  17. Alignment effects in two-photon double ionization of H2 in femtosecond xuv laser pulses

    International Nuclear Information System (INIS)

    Guan Xiaoxu; Bartschat, Klaus; Schneider, Barry I.

    2011-01-01

    Triple-differential cross sections for two-photon double ionization of the aligned hydrogen molecule at the equilibrium distance are presented for a central photon energy of 30 eV. The temporal response of the laser-driven molecule is investigated by solving the time-dependent Schroedinger equation in full dimensionality using two-center elliptical coordinates and a finite-element discrete-variable-representation approach. The molecular orientation is found to have a strong effect on the emission modes of the two correlated photoelectrons. This molecular effect is most noticeable when the molecular axis and the laser polarization vector are oriented parallel to each other. For intermediate cases between the parallel and perpendicular geometries, the dominant emission modes for two-electron ejection oscillate between those for the two extreme cases. The contributions from different ionization channels are also analyzed in detail. Depending on the emission direction of the reference electron, the interference contributions from the various channels can be constructive or destructive at small alignment angles, while they always contribute constructively to the triple-differential cross sections near the perpendicular geometry.

  18. (Nearly) portable PIC code for parallel computers

    International Nuclear Information System (INIS)

    Decyk, V.K.

    1993-01-01

    As part of the Numerical Tokamak Project, the author has developed a (nearly) portable, one dimensional version of the GCPIC algorithm for particle-in-cell codes on parallel computers. This algorithm uses a spatial domain decomposition for the fields, and passes particles from one domain to another as the particles move spatially. With only minor changes, the code has been run in parallel on the Intel Delta, the Cray C-90, the IBM ES/9000 and a cluster of workstations. After a line by line translation into cmfortran, the code was also run on the CM-200. Impressive speeds have been achieved, both on the Intel Delta and the Cray C-90, around 30 nanoseconds per particle per time step. In addition, the author was able to isolate the data management modules, so that the physics modules were not changed much from their sequential version, and the data management modules can be used as open-quotes black boxes.close quotes

  19. Tracing Magnetic Fields With The Polarization Of Submillimeter Lines

    Science.gov (United States)

    Zhang, Heshou; Yan, Huirong

    2017-10-01

    Magnetic fields play important roles in many astrophysical processes. However, there is no universal diagnostic for the magnetic fields in the interstellar medium (ISM) and each magnetic tracer has its limitation. Any new detection method is thus valuable. Theoretical studies have shown that submillimeter fine-structure lines are polarized due to atomic alignment by Ultraviolet (UV) photon-excitation, which opens up a new avenue to probe interstellar magnetic fields. The method is applicable to all radiative-excitation dominant region, e.g., H II Regions, PDRs. The polarization of the submillimeter fine-structure lines induced by atomic alignment could be substantial and the applicability of using the spectro-polarimetry of atomic lines to trace magnetic fields has been supported by synthetic observations of simulated ISM in our recent paper. Our results demonstrate that the polarization of submillimeter atomic lines is a powerful magnetic tracer and add great value to the observational studies of the submilimeter astronomy.

  20. Understating Polarization in the Interstellar Medium Through the Theory of Radiative Torque Alignment

    Science.gov (United States)

    Caputo, Miranda; Andersson, B.-G.; Kulas, Kristin Rose

    2018-06-01

    Although it is known that the dust grains in the ISM align with magnetic fields, the alignment physics of these particles is still somewhat unclear. Utilizing direct observational data and Radiative Alignment Torque (RAT) theory, further constraints can be put onto this alignment. Due to the physics of this alignment, there is a linear relationship between the extinction of the light seen through a dust cloud (AV) and the wavelength of maximum polarization. A previous study, focusing on the Taurus cloud, found that there is a second, steeper relationship seen beyond an extinction of about four magnitudes, likely due to grain growth, in addition to the original linear relationship. We present early results from observations of low-to-medium extinction lines of sight in the starless cloud L183 (aka L134N), aimed at testing the Taurus results. We are currently extending the survey of stars behind L183 to higher extinctions to better probe the origins of the bifurcation seen in the Taurus results.

  1. IMF By associated interhemispheric asymmetries in ionospheric convection and field-aligned currents

    Science.gov (United States)

    Kunduri, B.; Baker, J.; Ruohoniemi, J. M.; Clausen, L.; Ribeiro, A.

    2012-12-01

    The solar wind-magnetosphere interaction plays an important role in controlling the dynamics of ionospheric convection. It is widely known that the By component of IMF generates asymmetries in ionospheric convection between the northern and southern polar caps. Some studies show that IMF By-generated electric field penetrates into the closed magnetosphere producing differences in the high latitude ionospheric convection between hemispheres. The differences in convection were attributed to field-aligned potential drop between hemispheres resulting in flow of interhemispheric field aligned currents. In the current paper we present interhemispheric observations of high latitude ionospheric convection on closed field lines in the noon-dusk sector. The observations reveal that the convection is stronger in the northern (southern) hemisphere when IMF By is positive (negative) irrespective of season. The inter-hemispheric differences can be attributed to the flow of interhemispheric field aligned currents which support the existence of oppositely-directed zonal plasma flows in the closed field line regions, suppressing the convection in one hemisphere and aiding it in the other. We estimate the strength of these currents, analyze their characteristics and identify the various factors such as magnetic local time, magnetic latitude and ionospheric conductivity that impact them.

  2. Laser beam alignment and profilometry using diagnostic fluorescent safety mirrors

    Science.gov (United States)

    Lizotte, Todd E.

    2011-03-01

    There are a wide range of laser beam delivery systems in use for various purposes; including industrial and medical applications. Virtually all such beam delivery systems for practical purposes employ optical systems comprised of mirrors and lenses to shape, focus and guide the laser beam down to the material being processed. The goal of the laser beam delivery is to set the optimum parameters and to "fold" the beam path to reduce the mechanical length of the optical system, thereby allowing a physically compact system. In many cases, even a compact system can incorporate upwards of six mirrors and a comparable number of lenses all needing alignment so they are collinear. One of the major requirements for use of such systems in industry is a method of safe alignment. The alignment process requires that the aligner determine where the beam strikes each element. The aligner should also preferably be able to determine the shape or pattern of the laser beam at that point and its relative power. These alignments are further compounded in that the laser beams generated are not visible to the unaided human eye. Such beams are also often of relatively high power levels, and are thereby a significant hazard to the eyes of the aligner. Obvious an invisible beam makes it nearly impossible to align laser system without some form of optical assistance. The predominant method of visually aligning the laser beam delivery is the use of thermal paper, paper cards or fluorescing card material. The use of paper products which have limited power handling capability or coated plastics can produce significant debris and contaminants within the beam line that ultimately damage the optics. The use of the cards can also create significant laser light scatter jeopardizing the safety of the person aligning the system. This paper covers a new safety mirror design for use with at various UV and Near IR wavelengths (193 nm to 1064 nm) within laser beam delivery systems and how its use can

  3. Sensing Characteristics of A Precision Aligner Using Moire Gratings for Precision Alignment System

    Institute of Scientific and Technical Information of China (English)

    ZHOU Lizhong; Hideo Furuhashi; Yoshiyuki Uchida

    2001-01-01

    Sensing characteristics of a precision aligner using moire gratings for precision alignment sysem has been investigated. A differential moire alignment system and a modified alignment system were used. The influence of the setting accuracy of the gap length and inclination of gratings on the alignment accuracy has been studied experimentally and theoretically. Setting accuracy of the gap length less than 2.5μm is required in modified moire alignment. There is no influence of the gap length on the alignment accuracy in the differential alignment system. The inclination affects alignment accuracies in both differential and modified moire alignment systems.

  4. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    Z. Szillasi and G. Gomez.

    2013-01-01

    When CMS is opened up, major components of the Link and Barrel Alignment systems will be removed. This operation, besides allowing for maintenance of the detector underneath, is needed for making interventions that will reinforce the alignment measurements and make the operation of the alignment system more reliable. For that purpose and also for their general maintenance and recalibration, the alignment components will be transferred to the Alignment Lab situated in the ISR area. For the track-based alignment, attention is focused on the determination of systematic uncertainties, which have become dominant, since now there is a large statistics of muon tracks. This will allow for an improved Monte Carlo misalignment scenario and updated alignment position errors, crucial for high-momentum muon analysis such as Z′ searches.

  5. Triangular Alignment (TAME). A Tensor-based Approach for Higher-order Network Alignment

    Energy Technology Data Exchange (ETDEWEB)

    Mohammadi, Shahin [Purdue Univ., West Lafayette, IN (United States); Gleich, David F. [Purdue Univ., West Lafayette, IN (United States); Kolda, Tamara G. [Sandia National Laboratories (SNL-CA), Livermore, CA (United States); Grama, Ananth [Purdue Univ., West Lafayette, IN (United States)

    2015-11-01

    Network alignment is an important tool with extensive applications in comparative interactomics. Traditional approaches aim to simultaneously maximize the number of conserved edges and the underlying similarity of aligned entities. We propose a novel formulation of the network alignment problem that extends topological similarity to higher-order structures and provide a new objective function that maximizes the number of aligned substructures. This objective function corresponds to an integer programming problem, which is NP-hard. Consequently, we approximate this objective function as a surrogate function whose maximization results in a tensor eigenvalue problem. Based on this formulation, we present an algorithm called Triangular AlignMEnt (TAME), which attempts to maximize the number of aligned triangles across networks. We focus on alignment of triangles because of their enrichment in complex networks; however, our formulation and resulting algorithms can be applied to general motifs. Using a case study on the NAPABench dataset, we show that TAME is capable of producing alignments with up to 99% accuracy in terms of aligned nodes. We further evaluate our method by aligning yeast and human interactomes. Our results indicate that TAME outperforms the state-of-art alignment methods both in terms of biological and topological quality of the alignments.

  6. The effect of dry shear aligning of nanotube thin films on the photovoltaic performance of carbon nanotube-silicon solar cells.

    Science.gov (United States)

    Stolz, Benedikt W; Tune, Daniel D; Flavel, Benjamin S

    2016-01-01

    Recent results in the field of carbon nanotube-silicon solar cells have suggested that the best performance is obtained when the nanotube film provides good coverage of the silicon surface and when the nanotubes in the film are aligned parallel to the surface. The recently developed process of dry shear aligning - in which shear force is applied to the surface of carbon nanotube thin films in the dry state, has been shown to yield nanotube films that are very flat and in which the surface nanotubes are very well aligned in the direction of shear. It is thus reasonable to expect that nanotube films subjected to dry shear aligning should outperform otherwise identical films formed by other processes. In this work, the fabrication and characterisation of carbon nanotube-silicon solar cells using such films is reported, and the photovoltaic performance of devices produced with and without dry shear aligning is compared.

  7. Strategy and validation of fiducialisation for the pre-alignment of CLIC components

    CERN Document Server

    Griffet, S; Kemppinen, J; Mainaud Durand, H; Rude, V; Sterbini, G

    2012-01-01

    The feasibility of the high energy e+ e- linear collider CLIC (Compact Linear Collider) is very dependent on the ability to accurately pre-align its components. There are two 20 km long Main Linacs which meet in an interaction point (IP). The Main Linacs are composed of thousands of 2 m long modules. One of the challenges is to meet very tight alignment tolerances at the level of CLIC module: for example, the magnetic centre of a Drive Beam Quad needs to be aligned within 20 µm rms with respect to a straight line. Such accuracies cannot be achieved using usual measurement devices. Thus it is necessary to work in close collaboration with the metrology lab. To test and improve many critical points, including alignment, a CLIC mock-up is being assembled at CERN. This paper describes the application of the strategy of fiducialisation for the pre-alignment of CLIC mock-up components. It also deals with the first results obtained by performing measurements using a CMM (Coordinate Measuring Machine) to ensure the f...

  8. The influence of atomic alignment on absorption and emission spectroscopy

    Science.gov (United States)

    Zhang, Heshou; Yan, Huirong; Richter, Philipp

    2018-06-01

    Spectroscopic observations play essential roles in astrophysics. They are crucial for determining physical parameters in the universe, providing information about the chemistry of various astronomical environments. The proper execution of the spectroscopic analysis requires accounting for all the physical effects that are compatible to the signal-to-noise ratio. We find in this paper the influence on spectroscopy from the atomic/ground state alignment owing to anisotropic radiation and modulated by interstellar magnetic field, has significant impact on the study of interstellar gas. In different observational scenarios, we comprehensively demonstrate how atomic alignment influences the spectral analysis and provide the expressions for correcting the effect. The variations are even more pronounced for multiplets and line ratios. We show the variation of the deduced physical parameters caused by the atomic alignment effect, including alpha-to-iron ratio ([X/Fe]) and ionisation fraction. Synthetic observations are performed to illustrate the visibility of such effect with current facilities. A study of PDRs in ρ Ophiuchi cloud is presented to demonstrate how to account for atomic alignment in practice. Our work has shown that due to its potential impact, atomic alignment has to be included in an accurate spectroscopic analysis of the interstellar gas with current observational capability.

  9. Electron re-scattering from aligned linear molecules using the R-matrix method

    International Nuclear Information System (INIS)

    Harvey, A G; Tennyson, J

    2009-01-01

    Electron re-scattering in a strong laser field provides an important probe of molecular structure and processes. The laser field drives the ionization of the molecule, followed by acceleration and subsequent recollision of the electron with the parent molecular ion, the scattered electrons carry information about the nuclear geometry and electronic states of the molecular ion. It is advantageous in strong field experiments to work with aligned molecules, which introduces extra physics compared to the standard gas-phase, electron-molecule scattering problem. The formalism for scattering from oriented linear molecules is presented and applied to H 2 and CO 2 . Differential cross sections are presented for (re-)scattering by these systems concentrating on the most common, linear alignment. In H 2 these cross sections show significant angular structure which, particularly for a scattering angle of 90 deg., are predicted to vary significantly between re-collisions stimulated by an even or an odd number of photons. In CO 2 these cross sections are zero indicating the necessity of using non-parallel alignment with this molecule.

  10. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez and J. Pivarski

    2011-01-01

    Alignment efforts in the first few months of 2011 have shifted away from providing alignment constants (now a well established procedure) and focussed on some critical remaining issues. The single most important task left was to understand the systematic differences observed between the track-based (TB) and hardware-based (HW) barrel alignments: a systematic difference in r-φ and in z, which grew as a function of z, and which amounted to ~4-5 mm differences going from one end of the barrel to the other. This difference is now understood to be caused by the tracker alignment. The systematic differences disappear when the track-based barrel alignment is performed using the new “twist-free” tracker alignment. This removes the largest remaining source of systematic uncertainty. Since the barrel alignment is based on hardware, it does not suffer from the tracker twist. However, untwisting the tracker causes endcap disks (which are aligned ...

  11. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    Gervasio Gomez

    The main progress of the muon alignment group since March has been in the refinement of both the track-based alignment for the DTs and the hardware-based alignment for the CSCs. For DT track-based alignment, there has been significant improvement in the internal alignment of the superlayers inside the DTs. In particular, the distance between superlayers is now corrected, eliminating the residual dependence on track impact angles, and good agreement is found between survey and track-based corrections. The new internal geometry has been approved to be included in the forthcoming reprocessing of CRAFT samples. The alignment of DTs with respect to the tracker using global tracks has also improved significantly, since the algorithms use the latest B-field mapping, better run selection criteria, optimized momentum cuts, and an alignment is now obtained for all six degrees of freedom (three spatial coordinates and three rotations) of the aligned DTs. This work is ongoing and at a stage where we are trying to unders...

  12. HAL: a hierarchical format for storing and analyzing multiple genome alignments.

    Science.gov (United States)

    Hickey, Glenn; Paten, Benedict; Earl, Dent; Zerbino, Daniel; Haussler, David

    2013-05-15

    Large multiple genome alignments and inferred ancestral genomes are ideal resources for comparative studies of molecular evolution, and advances in sequencing and computing technology are making them increasingly obtainable. These structures can provide a rich understanding of the genetic relationships between all subsets of species they contain. Current formats for storing genomic alignments, such as XMFA and MAF, are all indexed or ordered using a single reference genome, however, which limits the information that can be queried with respect to other species and clades. This loss of information grows with the number of species under comparison, as well as their phylogenetic distance. We present HAL, a compressed, graph-based hierarchical alignment format for storing multiple genome alignments and ancestral reconstructions. HAL graphs are indexed on all genomes they contain. Furthermore, they are organized phylogenetically, which allows for modular and parallel access to arbitrary subclades without fragmentation because of rearrangements that have occurred in other lineages. HAL graphs can be created or read with a comprehensive C++ API. A set of tools is also provided to perform basic operations, such as importing and exporting data, identifying mutations and coordinate mapping (liftover). All documentation and source code for the HAL API and tools are freely available at http://github.com/glennhickey/hal. hickey@soe.ucsc.edu or haussler@soe.ucsc.edu Supplementary data are available at Bioinformatics online.

  13. Revisiting the phylogeny of Zoanthidea (Cnidaria: Anthozoa): Staggered alignment of hypervariable sequences improves species tree inference.

    Science.gov (United States)

    Swain, Timothy D

    2018-01-01

    The recent rapid proliferation of novel taxon identification in the Zoanthidea has been accompanied by a parallel propagation of gene trees as a tool of species discovery, but not a corresponding increase in our understanding of phylogeny. This disparity is caused by the trade-off between the capabilities of automated DNA sequence alignment and data content of genes applied to phylogenetic inference in this group. Conserved genes or segments are easily aligned across the order, but produce poorly resolved trees; hypervariable genes or segments contain the evolutionary signal necessary for resolution and robust support, but sequence alignment is daunting. Staggered alignments are a form of phylogeny-informed sequence alignment composed of a mosaic of local and universal regions that allow phylogenetic inference to be applied to all nucleotides from both hypervariable and conserved gene segments. Comparisons between species tree phylogenies inferred from all data (staggered alignment) and hypervariable-excluded data (standard alignment) demonstrate improved confidence and greater topological agreement with other sources of data for the complete-data tree. This novel phylogeny is the most comprehensive to date (in terms of taxa and data) and can serve as an expandable tool for evolutionary hypothesis testing in the Zoanthidea. Spanish language abstract available in Text S1. Translation by L. O. Swain, DePaul University, Chicago, Illinois, 60604, USA. Copyright © 2017 Elsevier Inc. All rights reserved.

  14. Applicability of Alignment and Combination Rules to Burst Pressure Prediction of Multiple-flawed Steam Generator Tube

    Energy Technology Data Exchange (ETDEWEB)

    Lee, Myeong Woo; Kim, Ji Seok; Kim, Yun Jae [Korea University, Seoul (Korea, Republic of); Jeon, Jun Young [Doosan Heavy Industries and Consruction, Seoul (Korea, Republic of); Lee, Dong Min [Korea Plant Service and Engineering, Technical Research and Development Institute, Naju (Korea, Republic of)

    2016-05-15

    Alignment and combination rules are provided by various codes and standards. These rules are used to determine whether multiple flaws should be treated as non-aligned or as coplanar, and independent or combined flaws. Experimental results on steam generator (SG) tube specimens containing multiple axial part-through-wall (PTW) flaws at room temperature (RT) are compared with assessment results based on the alignment and combination rules of the codes and standards. In case of axial collinear flaws, ASME, JSME, and BS7910 treated multiple flaws as independent flaws and API 579, A16, and FKM treated multiple flaws as combined single flaw. Assessment results of combined flaws were conservative. In case of axial non-aligned flaws, almost flaws were aligned and assessment results well correlate with experimental data. In case of axial parallel flaws, both effective flaw lengths of aligned flaws and separated flaws was are same because of each flaw length were same. This study investigates the applicability of alignment and combination rules for multiple flaws on the failure behavior of Alloy 690TT steam generator (SG) tubes that widely used in the nuclear power plan. Experimental data of burst tests on Alloy 690TT tubes with single and multiple flaws that conducted at room temperature (RT) by Kim el al. compared with the alignment rules of these codes and standards. Burst pressure of SG tubes with flaws are predicted using limit load solutions that provide by EPRI Handbook.

  15. Changes in collection efficiency in nylon net filter media through magnetic alignment of elongated aerosol particles.

    Science.gov (United States)

    Lam, Christopher O; Finlay, W H

    2009-10-01

    Fiber aerosols tend to align parallel to surrounding fluid streamlines in shear flows, making their filtration more difficult. However, previous research indicates that composite particles made from cromoglycic acid fibers coated with small nanoscaled magnetite particles can align with an applied magnetic field. The present research explored the effect of magnetically aligning these fibers to increase their filtration. Nylon net filters were challenged with the aerosol fibers, and efficiency tests were performed with and without a magnetic field applied perpendicular to the flow direction. We investigated the effects of varying face velocities, the amount of magnetite material on the aerosol particles, and magnetic field strengths. Findings from the experiments, matched by supporting single-fiber theories, showed significant efficiency increases at the low face velocity of 1.5 cm s(-1) at all magnetite compositions, with efficiencies more than doubling due to magnetic field alignment in certain cases. At a higher face velocity of 5.12 cm s(-1), filtration efficiencies were less affected by the magnetic field alignment being, at most, 43% higher for magnetite weight compositions up to 30%, while at a face velocity of 10.23 cm s(-1) alignment effects were insignificant. In most cases, efficiencies became independent of magnetic field strength above 50 mT, suggesting full alignment of the fibers. The present data suggest that fiber alignment in a magnetic field may warrant applications in the filtration and detection of fibers, such as asbestos.

  16. Improved magnetic field line design for TMX

    International Nuclear Information System (INIS)

    Logan, B.G.; Baldwin, D.E.; Foote, J.H.; Chargin, A.K.; Hinkle, R.E.; Hussung, R.O.; Damm, C.C.

    1977-01-01

    Optimization of the currents in the TMX magnet set leads to a field line configuration which has a central solenoidal region uniform in parallel B parallel to within 10 percent over a 2m length. The field design has sufficient flexibility to meet all three physics objectives of the TMX experiment

  17. Progress in linear optics, non-linear optics and surface alignment of liquid crystals

    Science.gov (United States)

    Ong, H. L.; Meyer, R. B.; Hurd, A. J.; Karn, A. J.; Arakelian, S. M.; Shen, Y. R.; Sanda, P. N.; Dove, D. B.; Jansen, S. A.; Hoffmann, R.

    We first discuss the progress in linear optics, in particular, the formulation and application of geometrical-optics approximation and its generalization. We then discuss the progress in non-linear optics, in particular, the enhancement of a first-order Freedericksz transition and intrinsic optical bistability in homeotropic and parallel oriented nematic liquid crystal cells. Finally, we discuss the liquid crystal alignment and surface effects on field-induced Freedericksz transition.

  18. Lining up device for the internal structures of a nuclear reactor vessel

    International Nuclear Information System (INIS)

    Silverblatt, B.L.

    1977-01-01

    The invention concerns a nuclear reactor of the type with a vessel, a vessel head carried at the top of this vessel by a core cylinder comprising a flange internally supported by the vessel, and an upper support structure supported between the core cylinder flange and the vessel head to align laterally the head, vessel, flange and support structure. A bottom key device is provided for lining up the flange, support structure and vessel, and an upper key device for laterally lining up support structure and the vessel head and for maintaining this alignment when they are removed simultaneously from the core cylinder and vessel. When re-assembling the reactor, the top support structure and the vessel head are lowered simultaneously so that an opening in the top alignment structure engages in the upper extension of the bottom alignment structure. A plurality of alignment stuctures may be utilised round the circumference of the reactor vessel. The disposition of the invention also facilitates the removal of the core cylinder from the reactor vessel. In this way, the alignment on re-assembly is ensured by the re-entry of the bottom extension under the flange of the core cylinder with the groove or keyway of the reactor vessel [fr

  19. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez

    Since December, the muon alignment community has focused on analyzing the data recorded so far in order to produce new DT and CSC Alignment Records for the second reprocessing of CRAFT data. Two independent algorithms were developed which align the DT chambers using global tracks, thus providing, for the first time, a relative alignment of the barrel with respect to the tracker. These results are an important ingredient for the second CRAFT reprocessing and allow, for example, a more detailed study of any possible mis-modelling of the magnetic field in the muon spectrometer. Both algorithms are constructed in such a way that the resulting alignment constants are not affected, to first order, by any such mis-modelling. The CSC chambers have not yet been included in this global track-based alignment due to a lack of statistics, since only a few cosmics go through the tracker and the CSCs. A strategy exists to align the CSCs using the barrel as a reference until collision tracks become available. Aligning the ...

  20. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez

    2011-01-01

    The Muon Alignment work now focuses on producing a new track-based alignment with higher track statistics, making systematic studies between the results of the hardware and track-based alignment methods and aligning the barrel using standalone muon tracks. Currently, the muon track reconstruction software uses a hardware-based alignment in the barrel (DT) and a track-based alignment in the endcaps (CSC). An important task is to assess the muon momentum resolution that can be achieved using the current muon alignment, especially for highly energetic muons. For this purpose, cosmic ray muons are used, since the rate of high-energy muons from collisions is very low and the event statistics are still limited. Cosmics have the advantage of higher statistics in the pT region above 100 GeV/c, but they have the disadvantage of having a mostly vertical topology, resulting in a very few global endcap muons. Only the barrel alignment has therefore been tested so far. Cosmic muons traversing CMS from top to bottom are s...

  1. Effects of parallel electron dynamics on plasma blob transport

    Energy Technology Data Exchange (ETDEWEB)

    Angus, Justin R.; Krasheninnikov, Sergei I. [University of California, San Diego, 9500 Gilman Drive, La Jolla, California 92093 (United States); Umansky, Maxim V. [Lawrence Livermore National Laboratory, 7000 East Avenue, Livermore, California 94550 (United States)

    2012-08-15

    The 3D effects on sheath connected plasma blobs that result from parallel electron dynamics are studied by allowing for the variation of blob density and potential along the magnetic field line and using collisional Ohm's law to model the parallel current density. The parallel current density from linear sheath theory, typically used in the 2D model, is implemented as parallel boundary conditions. This model includes electrostatic 3D effects, such as resistive drift waves and blob spinning, while retaining all of the fundamental 2D physics of sheath connected plasma blobs. If the growth time of unstable drift waves is comparable to the 2D advection time scale of the blob, then the blob's density gradient will be depleted resulting in a much more diffusive blob with little radial motion. Furthermore, blob profiles that are initially varying along the field line drive the potential to a Boltzmann relation that spins the blob and thereby acts as an addition sink of the 2D potential. Basic dimensionless parameters are presented to estimate the relative importance of these two 3D effects. The deviation of blob dynamics from that predicted by 2D theory in the appropriate limits of these parameters is demonstrated by a direct comparison of 2D and 3D seeded blob simulations.

  2. Simulation Exploration through Immersive Parallel Planes: Preprint

    Energy Technology Data Exchange (ETDEWEB)

    Brunhart-Lupo, Nicholas; Bush, Brian W.; Gruchalla, Kenny; Smith, Steve

    2016-03-01

    We present a visualization-driven simulation system that tightly couples systems dynamics simulations with an immersive virtual environment to allow analysts to rapidly develop and test hypotheses in a high-dimensional parameter space. To accomplish this, we generalize the two-dimensional parallel-coordinates statistical graphic as an immersive 'parallel-planes' visualization for multivariate time series emitted by simulations running in parallel with the visualization. In contrast to traditional parallel coordinate's mapping the multivariate dimensions onto coordinate axes represented by a series of parallel lines, we map pairs of the multivariate dimensions onto a series of parallel rectangles. As in the case of parallel coordinates, each individual observation in the dataset is mapped to a polyline whose vertices coincide with its coordinate values. Regions of the rectangles can be 'brushed' to highlight and select observations of interest: a 'slider' control allows the user to filter the observations by their time coordinate. In an immersive virtual environment, users interact with the parallel planes using a joystick that can select regions on the planes, manipulate selection, and filter time. The brushing and selection actions are used to both explore existing data as well as to launch additional simulations corresponding to the visually selected portions of the input parameter space. As soon as the new simulations complete, their resulting observations are displayed in the virtual environment. This tight feedback loop between simulation and immersive analytics accelerates users' realization of insights about the simulation and its output.

  3. Alignment effects in two-photon double ionization of H{sub 2} in femtosecond xuv laser pulses

    Energy Technology Data Exchange (ETDEWEB)

    Guan Xiaoxu; Bartschat, Klaus [Department of Physics and Astronomy, Drake University, Des Moines, Iowa 50311 (United States); Schneider, Barry I. [Office of Cyberinfrastructure, National Science Foundation, Arlington, Virgina 22230 (United States)

    2011-09-15

    Triple-differential cross sections for two-photon double ionization of the aligned hydrogen molecule at the equilibrium distance are presented for a central photon energy of 30 eV. The temporal response of the laser-driven molecule is investigated by solving the time-dependent Schroedinger equation in full dimensionality using two-center elliptical coordinates and a finite-element discrete-variable-representation approach. The molecular orientation is found to have a strong effect on the emission modes of the two correlated photoelectrons. This molecular effect is most noticeable when the molecular axis and the laser polarization vector are oriented parallel to each other. For intermediate cases between the parallel and perpendicular geometries, the dominant emission modes for two-electron ejection oscillate between those for the two extreme cases. The contributions from different ionization channels are also analyzed in detail. Depending on the emission direction of the reference electron, the interference contributions from the various channels can be constructive or destructive at small alignment angles, while they always contribute constructively to the triple-differential cross sections near the perpendicular geometry.

  4. Parallel hole collimator acceptance tests for SPECT and planar studies

    International Nuclear Information System (INIS)

    Babicheva, R.R.; Bennie, D.N.; Collins, L.T.; Gruenwald, S.M.

    1998-01-01

    Full text: Different kinds of collimator damage can occur either during shipping or from regular use. Imperfections of construction along the strips or their connections give rise to nonperpendicular hole alignments to the crystal face and can produce potential problems such as ring artifacts and image degradation. Gamma camera collimator hole alignments and integrity were compared in four parallel hole high resolution collimators-two new cast and two used foil collimators, one with damage to the protective surface. [1] The point source flood image of the defective collimator was non-circular as were the images of cast collimators. The image of new foil collimator was circular. [2] High count sheet flood did not show any imperfections. [3] Bone mineral densitometer was used to perform collimated X-ray beam. The collimator was placed on the scanning bed with an X-ray cassette placed directly above it. The damaged area was well demonstrated. [4] The COR offset test was taken at two extreme radii. The offset value with the defective collimator is increased by 0.53 pixel or 129% with increase of COR from radius 14 cm to 28cm. [5] The collimator hole alignment test involves performing multiple measurements of COR along the length of the collimator, and checking for variations in COR with both position of source and angle of rotation. The maximum variation in COR of the defective collimator hole alignment was 1.13 mm. Collimators require testing when new and at regular intervals, or following damage. The point source test can be used for foil collimators. The most sensitive tests were collimated X-ray source, COR offset test and collimator hole alignment

  5. Alignment-Annotator web server: rendering and annotating sequence alignments.

    Science.gov (United States)

    Gille, Christoph; Fähling, Michael; Weyand, Birgit; Wieland, Thomas; Gille, Andreas

    2014-07-01

    Alignment-Annotator is a novel web service designed to generate interactive views of annotated nucleotide and amino acid sequence alignments (i) de novo and (ii) embedded in other software. All computations are performed at server side. Interactivity is implemented in HTML5, a language native to web browsers. The alignment is initially displayed using default settings and can be modified with the graphical user interfaces. For example, individual sequences can be reordered or deleted using drag and drop, amino acid color code schemes can be applied and annotations can be added. Annotations can be made manually or imported (BioDAS servers, the UniProt, the Catalytic Site Atlas and the PDB). Some edits take immediate effect while others require server interaction and may take a few seconds to execute. The final alignment document can be downloaded as a zip-archive containing the HTML files. Because of the use of HTML the resulting interactive alignment can be viewed on any platform including Windows, Mac OS X, Linux, Android and iOS in any standard web browser. Importantly, no plugins nor Java are required and therefore Alignment-Anotator represents the first interactive browser-based alignment visualization. http://www.bioinformatics.org/strap/aa/ and http://strap.charite.de/aa/. © The Author(s) 2014. Published by Oxford University Press on behalf of Nucleic Acids Research.

  6. Efficient alignment of pyrosequencing reads for re-sequencing applications

    Directory of Open Access Journals (Sweden)

    Russo Luis MS

    2011-05-01

    Full Text Available Abstract Background Over the past few years, new massively parallel DNA sequencing technologies have emerged. These platforms generate massive amounts of data per run, greatly reducing the cost of DNA sequencing. However, these techniques also raise important computational difficulties mostly due to the huge volume of data produced, but also because of some of their specific characteristics such as read length and sequencing errors. Among the most critical problems is that of efficiently and accurately mapping reads to a reference genome in the context of re-sequencing projects. Results We present an efficient method for the local alignment of pyrosequencing reads produced by the GS FLX (454 system against a reference sequence. Our approach explores the characteristics of the data in these re-sequencing applications and uses state of the art indexing techniques combined with a flexible seed-based approach, leading to a fast and accurate algorithm which needs very little user parameterization. An evaluation performed using real and simulated data shows that our proposed method outperforms a number of mainstream tools on the quantity and quality of successful alignments, as well as on the execution time. Conclusions The proposed methodology was implemented in a software tool called TAPyR--Tool for the Alignment of Pyrosequencing Reads--which is publicly available from http://www.tapyr.net.

  7. Real-time monitoring of wind turbine generator shaft alignment using laser measurement.

    OpenAIRE

    Mankowski, O.; Wang, Q.

    2013-01-01

    Shaft Misalignment is one of the most common sources of trouble of wind turbine drive train when rigid couplings connect the shafts. Ideal alignment of the shaft is difficult to be obtained and the couplings attached to the shaft may present angular or parallel misalignment defined also as lateral and axially misalignment. Despite misalignment is often observed in the practice, there are relatively few studies on wind turbine shaft misalignment in the literature and their results are sometime...

  8. Fast parallel event reconstruction

    CERN Multimedia

    CERN. Geneva

    2010-01-01

    On-line processing of large data volumes produced in modern HEP experiments requires using maximum capabilities of modern and future many-core CPU and GPU architectures.One of such powerful feature is a SIMD instruction set, which allows packing several data items in one register and to operate on all of them, thus achievingmore operations per clock cycle. Motivated by the idea of using the SIMD unit ofmodern processors, the KF based track fit has been adapted for parallelism, including memory optimization, numerical analysis, vectorization with inline operator overloading, and optimization using SDKs. The speed of the algorithm has been increased in 120000 times with 0.1 ms/track, running in parallel on 16 SPEs of a Cell Blade computer.  Running on a Nehalem CPU with 8 cores it shows the processing speed of 52 ns/track using the Intel Threading Building Blocks. The same KF algorithm running on an Nvidia GTX 280 in the CUDA frameworkprovi...

  9. Parallel transport in ideal magnetohydrodynamics and applications to resistive wall modes

    International Nuclear Information System (INIS)

    Finn, J.M.; Gerwin, R.A.

    1996-01-01

    It is shown that in magnetohydrodynamics (MHD) with an ideal Ohm close-quote s law, in the presence of parallel heat flux, density gradient, temperature gradient, and parallel compression, but in the absence of perpendicular compressibility, there is an exact cancellation of the parallel transport terms. This cancellation is due to the fact that magnetic flux is advected in the presence of an ideal Ohm close-quote s law, and therefore parallel transport of temperature and density gives the same result as perpendicular advection of the same quantities. Discussions are also presented regarding parallel viscosity and parallel velocity shear, and the generalization to toroidal geometry. These results suggest that a correct generalization of the Hammett endash Perkins fluid operator [G. W. Hammett and F. W. Perkins, Phys. Rev. Lett. 64, 3019 (1990)] to simulate Landau damping for electromagnetic modes must give an operator that acts on the dynamics parallel to the perturbed magnetic field lines. copyright 1996 American Institute of Physics

  10. 375-nm ultraviolet-laser based non-line-of-sight underwater optical communication

    KAUST Repository

    Sun, Xiaobin; Cai, Wenqi; Alkhazragi, Omar; Ooi, Ee-Ning; He, Hongsen; Chaaban, Anas; Shen, Chao; Oubei, Hassan M.; Khan, Mohammed Zahed Mustafa; Ng, Tien Khee; Alouini, Mohamed-Slim; Ooi, Boon S.

    2018-01-01

    For circumventing the alignment requirement of line-of-sight (LOS) underwater wireless optical communication (UWOC), we demonstrated a non-line-of-sight (NLOS) UWOC link adequately enhanced using ultraviolet (UV) 375-nm laser. Path loss was chosen

  11. An Integrated Inductor For Parallel Interleaved Three-Phase Voltage Source Converters

    DEFF Research Database (Denmark)

    Gohil, Ghanshyamsinh Vijaysinh; Bede, Lorand; Teodorescu, Remus

    2016-01-01

    Three phase Voltage Source Converters (VSCs) are often connected in parallel to realize high current output converter system. The harmonic quality of the resultant switched output voltage can be improved by interleaving the carrier signals of these parallel connected VSCs. As a result, the line...... of the state-of-the-art filtering solution. The performance of the integrated inductor is also verified by the experimental measurements....

  12. Fabrication and design of bioactive agent coated, highly-aligned electrospun matrices for nerve tissue engineering: Preparation, characterization and application

    Science.gov (United States)

    Lee, Sang Jin; Heo, Min; Lee, Donghyun; Heo, Dong Nyoung; Lim, Ho-Nam; Kwon, Il Keun

    2017-12-01

    In this study, we designed highly-aligned thermoplastic polycarbonate urethane (PCU) fibrous scaffolds coated with bioactive compounds, such as Poly-L-Lysine (PLL) and Poly-L-Ornithine (PLO), to enhance cellular adhesion and directivity. These products were characterized by scanning electron microscope (SEM) analysis which demonstrated that highly aligned fiber strands were formed without beads when coated onto a mandrel rotating at 1800 rpm. During in vitro cell test, PLO-coated, aligned PCU scaffolds were found to have significantly higher proliferation rates than PLL coated and bare PCU scaffolds. Interestingly, dental pulp stem cells (DPSCs) were observed to stretch along the longitudinal axis parallel to the cell direction on highly aligned scaffolds. These results clearly confirm that our strategy may suggest a useful paradigm by inducing neural tissue repair as a means to remodeling and healing of tissue for restorative procedures in neural tissue engineering.

  13. CS-Studio Scan System Parallelization

    Energy Technology Data Exchange (ETDEWEB)

    Kasemir, Kay [ORNL; Pearson, Matthew R [ORNL

    2015-01-01

    For several years, the Control System Studio (CS-Studio) Scan System has successfully automated the operation of beam lines at the Oak Ridge National Laboratory (ORNL) High Flux Isotope Reactor (HFIR) and Spallation Neutron Source (SNS). As it is applied to additional beam lines, we need to support simultaneous adjustments of temperatures or motor positions. While this can be implemented via virtual motors or similar logic inside the Experimental Physics and Industrial Control System (EPICS) Input/Output Controllers (IOCs), doing so requires a priori knowledge of experimenters requirements. By adding support for the parallel control of multiple process variables (PVs) to the Scan System, we can better support ad hoc automation of experiments that benefit from such simultaneous PV adjustments.

  14. The precise self-assembly of individual carbon nanotubes using magnetic capturing and fluidic alignment

    Energy Technology Data Exchange (ETDEWEB)

    Shim, Joon S; Rust, Michael J; Do, Jaephil; Ahn, Chong H [Department of Electrical and Computer Engineering, Microsystems and BioMEMS Laboratory, University of Cincinnati, Cincinnati, OH 45221 (United States); Yun, Yeo-Heung; Schulz, Mark J [Department of Mechanical Engineering, University of Cincinnati, 45221 (United States); Shanov, Vesselin, E-mail: chong.ahn@uc.ed [Department of Chemical and Materials Engineering, University of Cincinnati, 45221 (United States)

    2009-08-12

    A new method for the self-assembly of a carbon nanotube (CNT) using magnetic capturing and fluidic alignment has been developed and characterized in this work. In this new method, the residual iron (Fe) catalyst positioned at one end of the CNT was utilized as a self-assembly driver to attract and position the CNT, while the assembled CNT was aligned by the shear force induced from the fluid flow through the assembly channel. The self-assembly procedures were successfully developed and the electrical properties of the assembled multi-walled carbon nanotube (MWNT) and single-walled carbon nanotube (SWNT) were fully characterized. The new assembly method developed in this work shows its feasibility for the precise self-assembly of parallel CNTs for electronic devices and nanobiosensors.

  15. The development of alignment turning system for precision len cells

    Science.gov (United States)

    Huang, Chien-Yao; Ho, Cheng-Fang; Wang, Jung-Hsing; Chung, Chien-Kai; Chen, Jun-Cheng; Chang, Keng-Shou; Kuo, Ching-Hsiang; Hsu, Wei-Yao; Chen, Fong-Zhi

    2017-08-01

    In general, the drop-in and cell-mounted assembly are used for standard and high performance optical system respectively. The optical performance is limited by the residual centration error and position accuracy of the conventional assembly. Recently, the poker chip assembly with high precision lens barrels that can overcome the limitation of conventional assembly is widely applied to ultra-high performance optical system. ITRC also develops the poker chip assembly solution for high numerical aperture objective lenses and lithography projection lenses. In order to achieve high precision lens cell for poker chip assembly, an alignment turning system (ATS) is developed. The ATS includes measurement, alignment and turning modules. The measurement module including a non-contact displacement sensor and an autocollimator can measure centration errors of the top and the bottom surface of a lens respectively. The alignment module comprising tilt and translation stages can align the optical axis of the lens to the rotating axis of the vertical lathe. The key specifications of the ATS are maximum lens diameter, 400mm, and radial and axial runout of the rotary table < 2 μm. The cutting performances of the ATS are surface roughness Ra < 1 μm, flatness < 2 μm, and parallelism < 5 μm. After measurement, alignment and turning processes on our ATS, the centration error of a lens cell with 200mm in diameter can be controlled in 10 arcsec. This paper also presents the thermal expansion of the hydrostatic rotating table. A poker chip assembly lens cell with three sub-cells is accomplished with average transmission centration error in 12.45 arcsec by fresh technicians. The results show that ATS can achieve high assembly efficiency for precision optical systems.

  16. Tibialis Anterior Tendon: A Reliable Anatomical Landmark Indicating the Ankle Centre. Potential Utility in Extra-Medullary Alignment During Total Knee Replacement

    Directory of Open Access Journals (Sweden)

    Avadhoot P. Kantak

    2017-07-01

    Full Text Available Background Extramedullary alignment is a well established surgical technique during total knee replacement. There are different methods to achieve accuracy but variability is quite extensive. To attain uniformity in the surgical technique we have been using the tibialis tendon to align our resection guide. This may prove to be a useful aid for surgeons during knee replacement surgery. Objectives The purpose of our study was to establish if tibialis anterior tendon represents the centre of ankle joint and if it could be used as an anatomical reference for alignment during knee replacement. Methods We designed a retrospective radiological cohort study. We studied sixty MRI scans of normal ankles. The centre of ankle joint was marked as a bisection point of the intermalleolar line at the level of superior surface of the talus. A line was drawn connecting the centre of Achilles tendon to the ankle centre and this was extended anteriorly. This line was found to have a constant relation to the ankle centre and it would simulate the positioning of the standard alignment device used. Results The tibialis anterior tendon lies less than 3mm medial to the ankle centre in the frontal plane. Conclusions We conclude that the tibialis anterior tendon can be used during knee replacement surgery as an accurate alignment guide.

  17. RevTrans: multiple alignment of coding DNA from aligned amino acid sequences

    DEFF Research Database (Denmark)

    Wernersson, Rasmus; Pedersen, Anders Gorm

    2003-01-01

    The simple fact that proteins are built from 20 amino acids while DNA only contains four different bases, means that the 'signal-to-noise ratio' in protein sequence alignments is much better than in alignments of DNA. Besides this information-theoretical advantage, protein alignments also benefit...... proteins. It is therefore preferable to align coding DNA at the amino acid level and it is for this purpose we have constructed the program RevTrans. RevTrans constructs a multiple DNA alignment by: (i) translating the DNA; (ii) aligning the resulting peptide sequences; and (iii) building a multiple DNA...

  18. Accelerating Smith-Waterman Alignment for Protein Database Search Using Frequency Distance Filtration Scheme Based on CPU-GPU Collaborative System

    Directory of Open Access Journals (Sweden)

    Yu Liu

    2015-01-01

    Full Text Available The Smith-Waterman (SW algorithm has been widely utilized for searching biological sequence databases in bioinformatics. Recently, several works have adopted the graphic card with Graphic Processing Units (GPUs and their associated CUDA model to enhance the performance of SW computations. However, these works mainly focused on the protein database search by using the intertask parallelization technique, and only using the GPU capability to do the SW computations one by one. Hence, in this paper, we will propose an efficient SW alignment method, called CUDA-SWfr, for the protein database search by using the intratask parallelization technique based on a CPU-GPU collaborative system. Before doing the SW computations on GPU, a procedure is applied on CPU by using the frequency distance filtration scheme (FDFS to eliminate the unnecessary alignments. The experimental results indicate that CUDA-SWfr runs 9.6 times and 96 times faster than the CPU-based SW method without and with FDFS, respectively.

  19. Accelerating Smith-Waterman Alignment for Protein Database Search Using Frequency Distance Filtration Scheme Based on CPU-GPU Collaborative System.

    Science.gov (United States)

    Liu, Yu; Hong, Yang; Lin, Chun-Yuan; Hung, Che-Lun

    2015-01-01

    The Smith-Waterman (SW) algorithm has been widely utilized for searching biological sequence databases in bioinformatics. Recently, several works have adopted the graphic card with Graphic Processing Units (GPUs) and their associated CUDA model to enhance the performance of SW computations. However, these works mainly focused on the protein database search by using the intertask parallelization technique, and only using the GPU capability to do the SW computations one by one. Hence, in this paper, we will propose an efficient SW alignment method, called CUDA-SWfr, for the protein database search by using the intratask parallelization technique based on a CPU-GPU collaborative system. Before doing the SW computations on GPU, a procedure is applied on CPU by using the frequency distance filtration scheme (FDFS) to eliminate the unnecessary alignments. The experimental results indicate that CUDA-SWfr runs 9.6 times and 96 times faster than the CPU-based SW method without and with FDFS, respectively.

  20. Field-aligned currents during northward IMF: Morphology and causes

    DEFF Research Database (Denmark)

    Vennerstrøm, Susanne; Moretto, T.; Rastätter, L.

    2005-01-01

    We present the results of a global MHD simulation of solar wind magnetosphere interaction during northward IMF. In particular, we emphasize the effect of the IMF B y component on the reconnection geometry and the mapping along field lines to the polar ionosphere, through field-aligned currents. We...... find that the existence and geometry of the polar cap is closely connected to the IMF B y component. During strictly northward IMF the simulated magnetosphere can remain essentially closed because the solar wind field lines reconnect in both hemispheres, thereby creating newly reconnected closed...... exist both on open and closed field lines and are created by the shear of the newly reconnected field lines against the mantle field as they are convected tailward by the solar wind. When the IMF rotates from northward toward east, the magnetospheric mapping regions of the NBZ currents likewise rotates...

  1. Theoretical and practical feasibility demonstration of a micrometric remotely controlled pre-alignment system for the CLIC linear collider

    CERN Document Server

    Mainaud Durand, H; Chritin, N; Griffet, S; Kemppinen, J; Sosin, M; Touze, T

    2011-01-01

    The active pre-alignment of the Compact Linear Collider (CLIC) is one of the key points of the project: the components must be pre-aligned w.r.t. a straight line within a few microns over a sliding window of 200 m, along the two linacs of 20 km each. The proposed solution consists of stretched wires of more than 200 m, overlapping over half of their length, which will be the reference of alignment. Wire Positioning Sensors (WPS), coupled to the supports to be pre-aligned, will perform precise and accurate measurements within a few microns w.r.t. these wires. A micrometric fiducialisation of the components and a micrometric alignment of the components on common supports will make the strategy of pre-alignment complete. In this paper, the global strategy of active pre-alignment is detailed and illustrated by the latest results demonstrating the feasibility of the proposed solution.

  2. New algorithms for parallel MRI

    International Nuclear Information System (INIS)

    Anzengruber, S; Ramlau, R; Bauer, F; Leitao, A

    2008-01-01

    Magnetic Resonance Imaging with parallel data acquisition requires algorithms for reconstructing the patient's image from a small number of measured lines of the Fourier domain (k-space). In contrast to well-known algorithms like SENSE and GRAPPA and its flavors we consider the problem as a non-linear inverse problem. However, in order to avoid cost intensive derivatives we will use Landweber-Kaczmarz iteration and in order to improve the overall results some additional sparsity constraints.

  3. Kemari: A Portable High Performance Fortran System for Distributed Memory Parallel Processors

    Directory of Open Access Journals (Sweden)

    T. Kamachi

    1997-01-01

    Full Text Available We have developed a compilation system which extends High Performance Fortran (HPF in various aspects. We support the parallelization of well-structured problems with loop distribution and alignment directives similar to HPF's data distribution directives. Such directives give both additional control to the user and simplify the compilation process. For the support of unstructured problems, we provide directives for dynamic data distribution through user-defined mappings. The compiler also allows integration of message-passing interface (MPI primitives. The system is part of a complete programming environment which also comprises a parallel debugger and a performance monitor and analyzer. After an overview of the compiler, we describe the language extensions and related compilation mechanisms in detail. Performance measurements demonstrate the compiler's applicability to a variety of application classes.

  4. The proposed alignment system for the Final Focus Test Beam at SLAC

    International Nuclear Information System (INIS)

    Ruland, R.E.; Fischer, G.E.

    1990-09-01

    This report describes the current state of work in progress with respect to the geometry, alignment requirements, scenarios, and hardware for meeting the tolerances of the Final Focus Test Beam (FFTB) at SLAC. The methods and systems proposed acknowledge that component motion at the micron level, from whatever cause (ground motion, thermal effects, etc.) must be measured on-line and compensated for on relatively short time scales. To provide an integrated alignment/positioning package, some unique designs for reference systems, calibration of effect electric and magnetic centers, and component movers are introduced. 24 refs., 28 figs

  5. Creating a medical English-Swedish dictionary using interactive word alignment

    Directory of Open Access Journals (Sweden)

    Zweigenbaum Pierre

    2006-10-01

    Full Text Available Abstract Background This paper reports on a parallel collection of rubrics from the medical terminology systems ICD-10, ICF, MeSH, NCSP and KSH97-P and its use for semi-automatic creation of an English-Swedish dictionary of medical terminology. The methods presented are relevant for many other West European language pairs than English-Swedish. Methods The medical terminology systems were collected in electronic format in both English and Swedish and the rubrics were extracted in parallel language pairs. Initially, interactive word alignment was used to create training data from a sample. Then the training data were utilised in automatic word alignment in order to generate candidate term pairs. The last step was manual verification of the term pair candidates. Results A dictionary of 31,000 verified entries has been created in less than three man weeks, thus with considerably less time and effort needed compared to a manual approach, and without compromising quality. As a side effect of our work we found 40 different translation problems in the terminology systems and these results indicate the power of the method for finding inconsistencies in terminology translations. We also report on some factors that may contribute to making the process of dictionary creation with similar tools even more expedient. Finally, the contribution is discussed in relation to other ongoing efforts in constructing medical lexicons for non-English languages. Conclusion In three man weeks we were able to produce a medical English-Swedish dictionary consisting of 31,000 entries and also found hidden translation errors in the utilized medical terminology systems.

  6. Creating a medical English-Swedish dictionary using interactive word alignment

    Science.gov (United States)

    Nyström, Mikael; Merkel, Magnus; Ahrenberg, Lars; Zweigenbaum, Pierre; Petersson, Håkan; Åhlfeldt, Hans

    2006-01-01

    Background This paper reports on a parallel collection of rubrics from the medical terminology systems ICD-10, ICF, MeSH, NCSP and KSH97-P and its use for semi-automatic creation of an English-Swedish dictionary of medical terminology. The methods presented are relevant for many other West European language pairs than English-Swedish. Methods The medical terminology systems were collected in electronic format in both English and Swedish and the rubrics were extracted in parallel language pairs. Initially, interactive word alignment was used to create training data from a sample. Then the training data were utilised in automatic word alignment in order to generate candidate term pairs. The last step was manual verification of the term pair candidates. Results A dictionary of 31,000 verified entries has been created in less than three man weeks, thus with considerably less time and effort needed compared to a manual approach, and without compromising quality. As a side effect of our work we found 40 different translation problems in the terminology systems and these results indicate the power of the method for finding inconsistencies in terminology translations. We also report on some factors that may contribute to making the process of dictionary creation with similar tools even more expedient. Finally, the contribution is discussed in relation to other ongoing efforts in constructing medical lexicons for non-English languages. Conclusion In three man weeks we were able to produce a medical English-Swedish dictionary consisting of 31,000 entries and also found hidden translation errors in the utilized medical terminology systems. PMID:17034649

  7. Creating a medical English-Swedish dictionary using interactive word alignment.

    Science.gov (United States)

    Nyström, Mikael; Merkel, Magnus; Ahrenberg, Lars; Zweigenbaum, Pierre; Petersson, Håkan; Ahlfeldt, Hans

    2006-10-12

    This paper reports on a parallel collection of rubrics from the medical terminology systems ICD-10, ICF, MeSH, NCSP and KSH97-P and its use for semi-automatic creation of an English-Swedish dictionary of medical terminology. The methods presented are relevant for many other West European language pairs than English-Swedish. The medical terminology systems were collected in electronic format in both English and Swedish and the rubrics were extracted in parallel language pairs. Initially, interactive word alignment was used to create training data from a sample. Then the training data were utilised in automatic word alignment in order to generate candidate term pairs. The last step was manual verification of the term pair candidates. A dictionary of 31,000 verified entries has been created in less than three man weeks, thus with considerably less time and effort needed compared to a manual approach, and without compromising quality. As a side effect of our work we found 40 different translation problems in the terminology systems and these results indicate the power of the method for finding inconsistencies in terminology translations. We also report on some factors that may contribute to making the process of dictionary creation with similar tools even more expedient. Finally, the contribution is discussed in relation to other ongoing efforts in constructing medical lexicons for non-English languages. In three man weeks we were able to produce a medical English-Swedish dictionary consisting of 31,000 entries and also found hidden translation errors in the utilized medical terminology systems.

  8. Development and Validation of a Multipoint Based Laser Alignment System for CLIC

    CERN Document Server

    Stern, G; Lackner, F; Mainaud-Durand, H; Piedigrossi, D; Sandomierski, J; Sosin, M; Geiger, A; Guillaume, S

    2013-01-01

    Alignment is one of the major challenges within CLIC study, since all accelerator components have to be aligned with accuracy up to 10 μm over sliding windows of 200 m. So far, the straight line reference concept has been based on stretched wires coupled with Wire Positioning Sensors. This concept should be validated through inter-comparison with an alternative solution. This paper proposes an alternative concept where laser beam acts as straight line reference and optical shutters coupled with cameras visualise the beam. The principle was first validated by a series of tests using low-cost components. Yet, in order to further decrease measurement uncertainty in this validation step, a high-precision automatised micrometric table and reference targets have been added to the setup. The paper presents the results obtained with this new equipment, in terms of measurement precision. In addition, the paper gives an overview of first tests done at long distance (up to 53 m), having emphasis on beam divergence

  9. Mechanical Design, Simulation, and Testing of Self-Aligning Gaussian Telescope and Stand for ITER LFS Reflectometer Diagnostic

    Science.gov (United States)

    Broughton, Rachel; Gomez, Michael; Zolfaghari, Ali; Morris, Lewis

    2016-10-01

    A self-aligning Gaussian telescope has been designed to compensate for the effect of movement in the ITER vacuum vessel on the transmission line. The purpose of the setup is to couple microwaves into and out of the vessel across the vacuum windows while allowing for both slow movements of the vessel, due to thermal growth, and rapid movements, due to vibrations and disruptions. Additionally, a test stand has been designed specifically to hold this telescope in order to imitate these movements. Consequently, this will allow for the assessment of the efficacy in applying the self-aligning Gaussian telescope approach. The motions of the test stand, as well as the stress on the telescope mechanism, have been virtually simulated using ANSYS workbench. A prototype of this test stand and self-aligning telescope will be built using a combination of custom machined parts and ordered parts. The completed mechanism will be tested at the lab in four different ways: slow single- and multi-direction movements, rapid multi-direction movement, functional laser alignment and self-aligning tests, and natural frequency tests. Once the prototype successfully passes all requirements, it will be tested with microwaves in the LFSR transmission line test stand at General Atomics. This work is supported by US DOE Contract No. DE-AC02-09CH11466.

  10. Creating a medical dictionary using word alignment: The influence of sources and resources

    Directory of Open Access Journals (Sweden)

    Åhlfeldt Hans

    2007-11-01

    Full Text Available Abstract Background Automatic word alignment of parallel texts with the same content in different languages is among other things used to generate dictionaries for new translations. The quality of the generated word alignment depends on the quality of the input resources. In this paper we report on automatic word alignment of the English and Swedish versions of the medical terminology systems ICD-10, ICF, NCSP, KSH97-P and parts of MeSH and how the terminology systems and type of resources influence the quality. Methods We automatically word aligned the terminology systems using static resources, like dictionaries, statistical resources, like statistically derived dictionaries, and training resources, which were generated from manual word alignment. We varied which part of the terminology systems that we used to generate the resources, which parts that we word aligned and which types of resources we used in the alignment process to explore the influence the different terminology systems and resources have on the recall and precision. After the analysis, we used the best configuration of the automatic word alignment for generation of candidate term pairs. We then manually verified the candidate term pairs and included the correct pairs in an English-Swedish dictionary. Results The results indicate that more resources and resource types give better results but the size of the parts used to generate the resources only partly affects the quality. The most generally useful resources were generated from ICD-10 and resources generated from MeSH were not as general as other resources. Systematic inter-language differences in the structure of the terminology system rubrics make the rubrics harder to align. Manually created training resources give nearly as good results as a union of static resources, statistical resources and training resources and noticeably better results than a union of static resources and statistical resources. The verified English

  11. Creating a medical dictionary using word alignment: the influence of sources and resources.

    Science.gov (United States)

    Nyström, Mikael; Merkel, Magnus; Petersson, Håkan; Ahlfeldt, Hans

    2007-11-23

    Automatic word alignment of parallel texts with the same content in different languages is among other things used to generate dictionaries for new translations. The quality of the generated word alignment depends on the quality of the input resources. In this paper we report on automatic word alignment of the English and Swedish versions of the medical terminology systems ICD-10, ICF, NCSP, KSH97-P and parts of MeSH and how the terminology systems and type of resources influence the quality. We automatically word aligned the terminology systems using static resources, like dictionaries, statistical resources, like statistically derived dictionaries, and training resources, which were generated from manual word alignment. We varied which part of the terminology systems that we used to generate the resources, which parts that we word aligned and which types of resources we used in the alignment process to explore the influence the different terminology systems and resources have on the recall and precision. After the analysis, we used the best configuration of the automatic word alignment for generation of candidate term pairs. We then manually verified the candidate term pairs and included the correct pairs in an English-Swedish dictionary. The results indicate that more resources and resource types give better results but the size of the parts used to generate the resources only partly affects the quality. The most generally useful resources were generated from ICD-10 and resources generated from MeSH were not as general as other resources. Systematic inter-language differences in the structure of the terminology system rubrics make the rubrics harder to align. Manually created training resources give nearly as good results as a union of static resources, statistical resources and training resources and noticeably better results than a union of static resources and statistical resources. The verified English-Swedish dictionary contains 24,000 term pairs in base

  12. Status and experiece with the alignment of Linac4

    CERN Document Server

    Fuchs, Jean-Frederic

    2016-01-01

    LINAC4 (L4) is an H- linear accelerator that will deliver, for the High Luminosity LHC (HL-LHC) project requirements, a beam of protons at 160 MeV energy to the PS complex and then to the LHC. Its connection to the PS booster will take place during the Long Shutdown 2 (LS2) in 2019-2020 or earlier if any major failure of the LINAC2. The Linac4 project requires the precise alignment with a tolerance of about +/- 0.2 mm in both the horizontal and vertical planes, of elements along approximately 150 m beam line. This paper will give a status, an overview of the challenges of the alignment, the issues solved by the survey section, the techniques and methodology used to realise the survey activities over the last five years.

  13. Research on Control Strategy of Complex Systems through VSC-HVDC Grid Parallel Device

    Directory of Open Access Journals (Sweden)

    Xue Mei-Juan

    2014-07-01

    Full Text Available After the completion of grid parallel, the device can turn to be UPFC, STATCOM, SSSC, research on the conversion circuit and transform method by corresponding switching operation. Accomplish the grid parallel and comprehensive control of the tie-line and stable operation and control functions of grid after parallel. Defines the function select operation switch matrix and grid parallel system branch variable, forming a switch matrix to achieve corresponding function of the composite system. Formed a criterion of the selection means to choose control strategy according to the switch matrix, to accomplish corresponding function. Put the grid parallel, STATCOM, SSSC and UPFC together as a system, improve the stable operation and flexible control of the power system.

  14. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    S. Szillasi

    2013-01-01

    The CMS detector has been gradually opened and whenever a wheel became exposed the first operation was the removal of the MABs, the sensor structures of the Hardware Barrel Alignment System. By the last days of June all 36 MABs have arrived at the Alignment Lab at the ISR where, as part of the Alignment Upgrade Project, they are refurbished with new Survey target holders. Their electronic checkout is on the way and finally they will be recalibrated. During LS1 the alignment system will be upgraded in order to allow more precise reconstruction of the MB4 chambers in Sector 10 and Sector 4. This requires new sensor components, so called MiniMABs (pictured below), that have already been assembled and calibrated. Image 6: Calibrated MiniMABs are ready for installation For the track-based alignment, the systematic uncertainties of the algorithm are under scrutiny: this study will enable the production of an improved Monte Carlo misalignment scenario and to update alignment position errors eventually, crucial...

  15. Promotion of Myogenic Maturation by Timely Application of Electric Field Along the Topographical Alignment.

    Science.gov (United States)

    Ko, Ung Hyun; Park, Sukhee; Bang, Hyunseung; Kim, Mina; Shin, Hyunjun; Shin, Jennifer H

    2018-05-01

    Engineered muscular substitutes can restore the impaired muscle functions when integrated properly into the host tissue. To generate functional muscles with sufficient contractility at the site of transplant, the in vitro construction of fully differentiated muscle fibers would be desired. Many previous reports have identified either topographical alignment or electrical stimulation as an effective tool to promote myogenic differentiation. However, optimization of spatial and temporal arrangement of these two physical cues for better differentiation and maturation of skeletal muscles has not been investigated. In this article, we introduce a novel cell culture system that allows simultaneous application of these two independent directional cues at both orthogonal and parallel arrangements. We then show that the parallel arrangement of the aligned topography and the electric field synergistically facilitates better differentiation and maturation of C2C12, generating myotubes with more fused nuclei. Addition of the electric stimulation at the late stage of myogenic differentiation is found to further improve cell fusion to form multinucleate myotubes through a phosphatidylinositol-3-OH-kinase-dependent pathway. As such, we successfully demonstrated that the combined stimulation of topographical and electrical cues could effectively enhance both myogenic differentiation and maturation in a temporal and orientation-dependent manner, providing the basis for therapeutic strategies for regenerative tissue engineering.

  16. Design and Test of Object Aligning Grippers for Industrial Applications

    DEFF Research Database (Denmark)

    Ellekilde, Lars-Peter; Petersen, Henrik Gordon

    2006-01-01

    In this paper we will present a new concept for gripping objects in industrial applications. We assume that a priori, the object pose is only known with a relative low accuracy. Despite this, our method can lead to high accuracy gripping suitable for e.g. industrial assembly. Our concept...... is to augment a simple parallel gripper by mounting a set of object speci?c jaws. Given the right shapes these jaws enable the gripper to automatically align the object, and thereby compensate for errors in the original object pose estimation. We will introduce a couple of automatic and semi-automatic design...

  17. Acceleration of auroral particles by magnetic-field aligned electric fields

    International Nuclear Information System (INIS)

    Block, L.P.

    1988-01-01

    Measurements on the S3-3 and Viking satellites appear to show that at least a large fraction of magnetic field-aligned potential drops are made up of multiple double layers. Solitons and double layers in U-shaped potential structures give rise to spiky electric fields also perpendicular to the magnetic field in agreement with satellite measurements. The large scale potential structures associated with inverted V-events are built up of many similar short-lived structures on a small scale. Viking measurements indicate that electric fields parallel to the magnetic field are almost always directed upward

  18. Parallel Simulation of Three-Dimensional Free Surface Fluid Flow Problems

    International Nuclear Information System (INIS)

    BAER, THOMAS A.; SACKINGER, PHILIP A.; SUBIA, SAMUEL R.

    1999-01-01

    Simulation of viscous three-dimensional fluid flow typically involves a large number of unknowns. When free surfaces are included, the number of unknowns increases dramatically. Consequently, this class of problem is an obvious application of parallel high performance computing. We describe parallel computation of viscous, incompressible, free surface, Newtonian fluid flow problems that include dynamic contact fines. The Galerkin finite element method was used to discretize the fully-coupled governing conservation equations and a ''pseudo-solid'' mesh mapping approach was used to determine the shape of the free surface. In this approach, the finite element mesh is allowed to deform to satisfy quasi-static solid mechanics equations subject to geometric or kinematic constraints on the boundaries. As a result, nodal displacements must be included in the set of unknowns. Other issues discussed are the proper constraints appearing along the dynamic contact line in three dimensions. Issues affecting efficient parallel simulations include problem decomposition to equally distribute computational work among a SPMD computer and determination of robust, scalable preconditioners for the distributed matrix systems that must be solved. Solution continuation strategies important for serial simulations have an enhanced relevance in a parallel coquting environment due to the difficulty of solving large scale systems. Parallel computations will be demonstrated on an example taken from the coating flow industry: flow in the vicinity of a slot coater edge. This is a three dimensional free surface problem possessing a contact line that advances at the web speed in one region but transitions to static behavior in another region. As such, a significant fraction of the computational time is devoted to processing boundary data. Discussion focuses on parallel speed ups for fixed problem size, a class of problems of immediate practical importance

  19. Optimization approaches to mpi and area merging-based parallel buffer algorithm

    Directory of Open Access Journals (Sweden)

    Junfu Fan

    Full Text Available On buffer zone construction, the rasterization-based dilation method inevitably introduces errors, and the double-sided parallel line method involves a series of complex operations. In this paper, we proposed a parallel buffer algorithm based on area merging and MPI (Message Passing Interface to improve the performances of buffer analyses on processing large datasets. Experimental results reveal that there are three major performance bottlenecks which significantly impact the serial and parallel buffer construction efficiencies, including the area merging strategy, the task load balance method and the MPI inter-process results merging strategy. Corresponding optimization approaches involving tree-like area merging strategy, the vertex number oriented parallel task partition method and the inter-process results merging strategy were suggested to overcome these bottlenecks. Experiments were carried out to examine the performance efficiency of the optimized parallel algorithm. The estimation results suggested that the optimization approaches could provide high performance and processing ability for buffer construction in a cluster parallel environment. Our method could provide insights into the parallelization of spatial analysis algorithm.

  20. Development of an alignment system for the CBM rich

    Energy Technology Data Exchange (ETDEWEB)

    Hoehne, Claudia; Mahmoud, Tariq; Bendarouach, Jordan [Justus Liebig University, Giessen (Germany); Collaboration: CBM-Collaboration

    2015-07-01

    The Compressed Baryonic Matter (CBM) experiment at the future FAIR complex will investigate the phase diagram of strongly interacting matter at high baryon density and moderate temperatures in A+A collisions from 4-35 AGeV. One of the key detector components required for the CBM physics program is the RICH detector, which is developed for efficient and clean electron identification and pion suppression. Main detector components are a CO{sub 2} gaseous radiator, MAPMT or MCP photo-detectors and spherical glass mirror tiles, used as focusing elements, with spectral reflectivity down to the UV range. An important aspect to guarantee a stable operation of the RICH detector is the alignment and continuous monitor of the mirrors. CLAM (Continuous Line Alignment Monitoring), an alignment procedure developed by the COMPASS experiment, is planned to be used also for the RICH mirror system. A smaller-scale version has been implemented in the CBM RICH prototype detector and tested at the Cern PS/T9 beamline in November 2014. Using a grid and target dots made of retro-reflective material, it is possible to align the mirrors and monitor their displacements over time by analyzing and applying mathematical calculations on photographic images of the grid and targets reflected on the mirrors. The concept, first data and results of image processing are presented and discussed.

  1. MaxAlign: maximizing usable data in an alignment

    DEFF Research Database (Denmark)

    Oliveira, Rodrigo Gouveia; Sackett, Peter Wad; Pedersen, Anders Gorm

    2007-01-01

    Align. In this paper we also introduce a new simple measure of tree similarity, Normalized Symmetric Similarity (NSS) that we consider useful for comparing tree topologies. CONCLUSION: We demonstrate how MaxAlign is helpful in detecting misaligned or defective sequences without requiring manual inspection. We also...

  2. Aligning for Innovation - Alignment Strategy to Drive Innovation

    Science.gov (United States)

    Johnson, Hurel; Teltschik, David; Bussey, Horace, Jr.; Moy, James

    2010-01-01

    With the sudden need for innovation that will help the country achieve its long-term space exploration objectives, the question of whether NASA is aligned effectively to drive the innovation that it so desperately needs to take space exploration to the next level should be entertained. Authors such as Robert Kaplan and David North have noted that companies that use a formal system for implementing strategy consistently outperform their peers. They have outlined a six-stage management systems model for implementing strategy, which includes the aligning of the organization towards its objectives. This involves the alignment of the organization from the top down. This presentation will explore the impacts of existing U.S. industrial policy on technological innovation; assess the current NASA organizational alignment and its impacts on driving technological innovation; and finally suggest an alternative approach that may drive the innovation needed to take the world to the next level of space exploration, with NASA truly leading the way.

  3. A parallel algorithm for 3D dislocation dynamics

    International Nuclear Information System (INIS)

    Wang Zhiqiang; Ghoniem, Nasr; Swaminarayan, Sriram; LeSar, Richard

    2006-01-01

    Dislocation dynamics (DD), a discrete dynamic simulation method in which dislocations are the fundamental entities, is a powerful tool for investigation of plasticity, deformation and fracture of materials at the micron length scale. However, severe computational difficulties arising from complex, long-range interactions between these curvilinear line defects limit the application of DD in the study of large-scale plastic deformation. We present here the development of a parallel algorithm for accelerated computer simulations of DD. By representing dislocations as a 3D set of dislocation particles, we show here that the problem of an interacting ensemble of dislocations can be converted to a problem of a particle ensemble, interacting with a long-range force field. A grid using binary space partitioning is constructed to keep track of node connectivity across domains. We demonstrate the computational efficiency of the parallel micro-plasticity code and discuss how O(N) methods map naturally onto the parallel data structure. Finally, we present results from applications of the parallel code to deformation in single crystal fcc metals

  4. Helium transfer line installation details.

    CERN Multimedia

    G. Perinic

    2007-01-01

    A particularity of the 32 m long four in one helium transfer line in between the cold box in USC55 and the cavern UX5 is the fact that the transfer line passes through a hole in the crane rail support beam. In order to ensure the alignment of the suspension rail in the interconnecting tunnel with the hole in the rail support as well as the connection points at both ends required precise measurements of the given geometries as well as the installation of a temporary target for the verification of the theoretical predictions.

  5. The relation between reconnected flux, the parallel electric field, and the reconnection rate in a three-dimensional kinetic simulation of magnetic reconnection

    International Nuclear Information System (INIS)

    Wendel, D. E.; Olson, D. K.; Hesse, M.; Kuznetsova, M.; Adrian, M. L.; Aunai, N.; Karimabadi, H.; Daughton, W.

    2013-01-01

    We investigate the distribution of parallel electric fields and their relationship to the location and rate of magnetic reconnection in a large particle-in-cell simulation of 3D turbulent magnetic reconnection with open boundary conditions. The simulation's guide field geometry inhibits the formation of simple topological features such as null points. Therefore, we derive the location of potential changes in magnetic connectivity by finding the field lines that experience a large relative change between their endpoints, i.e., the quasi-separatrix layer. We find a good correspondence between the locus of changes in magnetic connectivity or the quasi-separatrix layer and the map of large gradients in the integrated parallel electric field (or quasi-potential). Furthermore, we investigate the distribution of the parallel electric field along the reconnecting field lines. We find the reconnection rate is controlled by only the low-amplitude, zeroth and first–order trends in the parallel electric field while the contribution from fluctuations of the parallel electric field, such as electron holes, is negligible. The results impact the determination of reconnection sites and reconnection rates in models and in situ spacecraft observations of 3D turbulent reconnection. It is difficult through direct observation to isolate the loci of the reconnection parallel electric field amidst the large amplitude fluctuations. However, we demonstrate that a positive slope of the running sum of the parallel electric field along the field line as a function of field line length indicates where reconnection is occurring along the field line

  6. An Integrated Inductor for Parallel Interleaved VSCs and PWM Schemes for Flux Minimization

    DEFF Research Database (Denmark)

    Gohil, Ghanshyamsinh Vijaysinh; Bede, Lorand; Teodorescu, Remus

    2015-01-01

    The interleaving of the carrier signals of the parallel Voltage Source Converters (VSCs) can reduce the harmonic content in the resultant switched output voltages. As a result, the size of the line filter inductor can be reduced. However, in addition to the line filter, an inductive filter is often...

  7. Control rod housing alignment

    International Nuclear Information System (INIS)

    Dixon, R.C.; Deaver, G.A.; Punches, J.R.; Singleton, G.E.; Erbes, J.G.; Offer, H.P.

    1990-01-01

    This patent describes a process for measuring the vertical alignment between a hole in a core plate and the top of a corresponding control rod drive housing within a boiling water reactor. It comprises: providing an alignment apparatus. The alignment apparatus including a lower end for fitting to the top of the control rod drive housing; an upper end for fitting to the aperture in the core plate, and a leveling means attached to the alignment apparatus to read out the difference in angularity with respect to gravity, and alignment pin registering means for registering to the alignment pin on the core plate; lowering the alignment device on a depending support through a lattice position in the top guide through the hole in the core plate down into registered contact with the top of the control rod drive housing; registering the upper end to the sides of the hole in the core plate; registering the alignment pin registering means to an alignment pin on the core plate to impart to the alignment device the required angularity; and reading out the angle of the control rod drive housing with respect to the hole in the core plate through the leveling devices whereby the angularity of the top of the control rod drive housing with respect to the hole in the core plate can be determined

  8. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez

    2012-01-01

      A new muon alignment has been produced for 2012 A+B data reconstruction. It uses the latest Tracker alignment and single-muon data samples to align both DTs and CSCs. Physics validation has been performed and shows a modest improvement in stand-alone muon momentum resolution in the barrel, where the alignment is essentially unchanged from the previous version. The reference-target track-based algorithm using only collision muons is employed for the first time to align the CSCs, and a substantial improvement in resolution is observed in the endcap and overlap regions for stand-alone muons. This new alignment is undergoing the approval process and is expected to be deployed as part of a new global tag in the beginning of December. The pT dependence of the φ-bias in curvature observed in Monte Carlo was traced to a relative vertical misalignment between the Tracker and barrel muon systems. Moving the barrel as a whole to match the Tracker cures this pT dependence, leaving only the &phi...

  9. Simulation of beamline alignment operations

    International Nuclear Information System (INIS)

    Annese, C; Miller, M G.

    1999-01-01

    The CORBA-based Simulator was a Laboratory Directed Research and Development (LDRD) project that applied simulation techniques to explore critical questions about distributed control systems. The simulator project used a three-prong approach that studied object-oriented distribution tools, computer network modeling, and simulation of key control system scenarios. The National Ignition Facility's (NIF) optical alignment system was modeled to study control system operations. The alignment of NIF's 192 beamlines is a large complex operation involving more than 100 computer systems and 8000 mechanized devices. The alignment process is defined by a detailed set of procedures; however, many of the steps are deterministic. The alignment steps for a poorly aligned component are similar to that of a nearly aligned component; however, additional operations/iterations are required to complete the process. Thus, the same alignment operations will require variable amounts of time to perform depending on the current alignment condition as well as other factors. Simulation of the alignment process is necessary to understand beamline alignment time requirements and how shared resources such as the Output Sensor and Target Alignment Sensor effect alignment efficiency. The simulation has provided alignment time estimates and other results based on documented alignment procedures and alignment experience gained in the laboratory. Computer communication time, mechanical hardware actuation times, image processing algorithm execution times, etc. have been experimentally determined and incorporated into the model. Previous analysis of alignment operations utilized average implementation times for all alignment operations. Resource sharing becomes rather simple to model when only average values are used. The time required to actually implement the many individual alignment operations will be quite dynamic. The simulation model estimates the time to complete an operation using

  10. CAB-Align: A Flexible Protein Structure Alignment Method Based on the Residue-Residue Contact Area.

    Directory of Open Access Journals (Sweden)

    Genki Terashi

    Full Text Available Proteins are flexible, and this flexibility has an essential functional role. Flexibility can be observed in loop regions, rearrangements between secondary structure elements, and conformational changes between entire domains. However, most protein structure alignment methods treat protein structures as rigid bodies. Thus, these methods fail to identify the equivalences of residue pairs in regions with flexibility. In this study, we considered that the evolutionary relationship between proteins corresponds directly to the residue-residue physical contacts rather than the three-dimensional (3D coordinates of proteins. Thus, we developed a new protein structure alignment method, contact area-based alignment (CAB-align, which uses the residue-residue contact area to identify regions of similarity. The main purpose of CAB-align is to identify homologous relationships at the residue level between related protein structures. The CAB-align procedure comprises two main steps: First, a rigid-body alignment method based on local and global 3D structure superposition is employed to generate a sufficient number of initial alignments. Then, iterative dynamic programming is executed to find the optimal alignment. We evaluated the performance and advantages of CAB-align based on four main points: (1 agreement with the gold standard alignment, (2 alignment quality based on an evolutionary relationship without 3D coordinate superposition, (3 consistency of the multiple alignments, and (4 classification agreement with the gold standard classification. Comparisons of CAB-align with other state-of-the-art protein structure alignment methods (TM-align, FATCAT, and DaliLite using our benchmark dataset showed that CAB-align performed robustly in obtaining high-quality alignments and generating consistent multiple alignments with high coverage and accuracy rates, and it performed extremely well when discriminating between homologous and nonhomologous pairs of proteins

  11. CAB-Align: A Flexible Protein Structure Alignment Method Based on the Residue-Residue Contact Area.

    Science.gov (United States)

    Terashi, Genki; Takeda-Shitaka, Mayuko

    2015-01-01

    Proteins are flexible, and this flexibility has an essential functional role. Flexibility can be observed in loop regions, rearrangements between secondary structure elements, and conformational changes between entire domains. However, most protein structure alignment methods treat protein structures as rigid bodies. Thus, these methods fail to identify the equivalences of residue pairs in regions with flexibility. In this study, we considered that the evolutionary relationship between proteins corresponds directly to the residue-residue physical contacts rather than the three-dimensional (3D) coordinates of proteins. Thus, we developed a new protein structure alignment method, contact area-based alignment (CAB-align), which uses the residue-residue contact area to identify regions of similarity. The main purpose of CAB-align is to identify homologous relationships at the residue level between related protein structures. The CAB-align procedure comprises two main steps: First, a rigid-body alignment method based on local and global 3D structure superposition is employed to generate a sufficient number of initial alignments. Then, iterative dynamic programming is executed to find the optimal alignment. We evaluated the performance and advantages of CAB-align based on four main points: (1) agreement with the gold standard alignment, (2) alignment quality based on an evolutionary relationship without 3D coordinate superposition, (3) consistency of the multiple alignments, and (4) classification agreement with the gold standard classification. Comparisons of CAB-align with other state-of-the-art protein structure alignment methods (TM-align, FATCAT, and DaliLite) using our benchmark dataset showed that CAB-align performed robustly in obtaining high-quality alignments and generating consistent multiple alignments with high coverage and accuracy rates, and it performed extremely well when discriminating between homologous and nonhomologous pairs of proteins in both

  12. BinAligner: a heuristic method to align biological networks.

    Science.gov (United States)

    Yang, Jialiang; Li, Jun; Grünewald, Stefan; Wan, Xiu-Feng

    2013-01-01

    The advances in high throughput omics technologies have made it possible to characterize molecular interactions within and across various species. Alignments and comparison of molecular networks across species will help detect orthologs and conserved functional modules and provide insights on the evolutionary relationships of the compared species. However, such analyses are not trivial due to the complexity of network and high computational cost. Here we develop a mixture of global and local algorithm, BinAligner, for network alignments. Based on the hypotheses that the similarity between two vertices across networks would be context dependent and that the information from the edges and the structures of subnetworks can be more informative than vertices alone, two scoring schema, 1-neighborhood subnetwork and graphlet, were introduced to derive the scoring matrices between networks, besides the commonly used scoring scheme from vertices. Then the alignment problem is formulated as an assignment problem, which is solved by the combinatorial optimization algorithm, such as the Hungarian method. The proposed algorithm was applied and validated in aligning the protein-protein interaction network of Kaposi's sarcoma associated herpesvirus (KSHV) and that of varicella zoster virus (VZV). Interestingly, we identified several putative functional orthologous proteins with similar functions but very low sequence similarity between the two viruses. For example, KSHV open reading frame 56 (ORF56) and VZV ORF55 are helicase-primase subunits with sequence identity 14.6%, and KSHV ORF75 and VZV ORF44 are tegument proteins with sequence identity 15.3%. These functional pairs can not be identified if one restricts the alignment into orthologous protein pairs. In addition, BinAligner identified a conserved pathway between two viruses, which consists of 7 orthologous protein pairs and these proteins are connected by conserved links. This pathway might be crucial for virus packing and

  13. RF sputtering deposited a-IGZO films for LCD alignment layer application

    International Nuclear Information System (INIS)

    Wu, G.M.; Liu, C.Y.; Sahoo, A.K.

    2015-01-01

    Highlights: • a-IGZO nanolayer has been presented for alignment of liquid crystals in LCD. • RF sputtering deposition at an oblique angle has been performed to grow the films. • High transparency over 90% was obtained in the visible wavelength range. • The OCB cells exhibited fast on-off and short response time of 5.04 ms. • V–T characteristics proved high contrast ratio for LCD display applications. - Abstract: In this paper, amorphous indium gallium zinc oxide (a-IGZO) inorganic films were deposited at a fixed oblique angle using radio-frequency sputtering on indium tin oxide (ITO) glass as alternative alignment layer for liquid crystal displays. A series of experiments have been carried out to reveal the physical characteristics of the a-IGZO films, such as optical transmittance, X-ray diffraction (XRD), X-ray photoelectron spectroscopy (XPS), and atomic force microscopy (AFM). The special treatment a-IGZO films were used to fabricate liquid crystal (LC) cells and investigate the performances of these cells. Pretilt angles were measured with anti-parallel LC cells and voltage–transmittance (V–T) curve, contrast ratio, and response time were evaluated with optically compensated bend (OCB) LC cells. The electro-optical characteristics of the aligned homogenous LCs, and OCB mode cells based on the a-IGZO alignment layer were compared to those based on rubbing processed polyimide (PI). The results showed that the average transmittance in the visible wavelength range was higher than 90% for the a-IGZO alignment layer. The LC pretilt angle has been determined at about 6°. The evaluted cell critical voltage at maximum transmittance was 1.8 V, lower than the control cell using PI alignment layer. The OCB cell rise time and fall time were 1.55 ms and 3.49 ms, respectivly. A very quick response time of 5.04 ms has thus been achived. In addition, the study of V–T characteristics suggested higher contrast ratio for LCD display applications.

  14. RF sputtering deposited a-IGZO films for LCD alignment layer application

    Energy Technology Data Exchange (ETDEWEB)

    Wu, G.M., E-mail: wu@mail.cgu.edu.tw; Liu, C.Y.; Sahoo, A.K.

    2015-11-01

    Highlights: • a-IGZO nanolayer has been presented for alignment of liquid crystals in LCD. • RF sputtering deposition at an oblique angle has been performed to grow the films. • High transparency over 90% was obtained in the visible wavelength range. • The OCB cells exhibited fast on-off and short response time of 5.04 ms. • V–T characteristics proved high contrast ratio for LCD display applications. - Abstract: In this paper, amorphous indium gallium zinc oxide (a-IGZO) inorganic films were deposited at a fixed oblique angle using radio-frequency sputtering on indium tin oxide (ITO) glass as alternative alignment layer for liquid crystal displays. A series of experiments have been carried out to reveal the physical characteristics of the a-IGZO films, such as optical transmittance, X-ray diffraction (XRD), X-ray photoelectron spectroscopy (XPS), and atomic force microscopy (AFM). The special treatment a-IGZO films were used to fabricate liquid crystal (LC) cells and investigate the performances of these cells. Pretilt angles were measured with anti-parallel LC cells and voltage–transmittance (V–T) curve, contrast ratio, and response time were evaluated with optically compensated bend (OCB) LC cells. The electro-optical characteristics of the aligned homogenous LCs, and OCB mode cells based on the a-IGZO alignment layer were compared to those based on rubbing processed polyimide (PI). The results showed that the average transmittance in the visible wavelength range was higher than 90% for the a-IGZO alignment layer. The LC pretilt angle has been determined at about 6°. The evaluted cell critical voltage at maximum transmittance was 1.8 V, lower than the control cell using PI alignment layer. The OCB cell rise time and fall time were 1.55 ms and 3.49 ms, respectivly. A very quick response time of 5.04 ms has thus been achived. In addition, the study of V–T characteristics suggested higher contrast ratio for LCD display applications.

  15. Prediction of molecular alignment of nucleic acids in aligned media

    International Nuclear Information System (INIS)

    Wu Bin; Petersen, Michael; Girard, Frederic; Tessari, Marco; Wijmenga, Sybren S.

    2006-01-01

    We demonstrate - using the data base of all deposited DNA and RNA structures aligned in Pf1-medium and RDC refined - that for nucleic acids in a Pf1-medium the electrostatic alignment tensor can be predicted reliably and accurately via a simple and fast calculation based on the gyration tensor spanned out by the phosphodiester atoms. The rhombicity is well predicted over its full range from 0 to 0.66, while the alignment tensor orientation is predicted correctly for rhombicities up to ca. 0.4, for larger rhombicities it appears to deviate somewhat more than expected based on structural noise and measurement error. This simple analytical approach is based on the Debye-Huckel approximation for the electrostatic interaction potential, valid at distances sufficiently far away from a poly-ionic charged surface, a condition naturally enforced when the charge of alignment medium and solute are of equal sign, as for nucleic acids in a Pf1-phage medium. For the usual salt strengths and nucleic acid sizes, the Debye-Huckel screening length is smaller than the nucleic acid size, but large enough for the collective of Debye-Huckel spheres to encompass the whole molecule. The molecular alignment is then purely electrostatic, but it's functional form is under these conditions similar to that for steric alignment. The proposed analytical expression allows for very fast calculation of the alignment tensor and hence RDCs from the conformation of the nucleic acid molecule. This information provides opportunities for improved structure determination of nucleic acids, including better assessment of dynamics in (multi-domain) nucleic acids and the possibility to incorporate alignment tensor prediction from shape directly into the structure calculation process. The procedures are incorporated into MATLAB scripts, which are available on request

  16. COMPARISON OF 2D AND 3D APPROACHES FOR THE ALIGNMENT OF UAV AND LIDAR POINT CLOUDS

    Directory of Open Access Journals (Sweden)

    R. A. Persad

    2017-08-01

    Full Text Available The automatic alignment of 3D point clouds acquired or generated from different sensors is a challenging problem. The objective of the alignment is to estimate the 3D similarity transformation parameters, including a global scale factor, 3 rotations and 3 translations. To do so, corresponding anchor features are required in both data sets. There are two main types of alignment: i Coarse alignment and ii Refined Alignment. Coarse alignment issues include lack of any prior knowledge of the respective coordinate systems for a source and target point cloud pair and the difficulty to extract and match corresponding control features (e.g., points, lines or planes co-located on both point cloud pairs to be aligned. With the increasing use of UAVs, there is a need to automatically co-register their generated point cloud-based digital surface models with those from other data acquisition systems such as terrestrial or airborne lidar point clouds. This works presents a comparative study of two independent feature matching techniques for addressing 3D conformal point cloud alignment of UAV and lidar data in different 3D coordinate systems without any prior knowledge of the seven transformation parameters.

  17. AA, sandwich line with magnetic horn

    CERN Multimedia

    CERN PhotoLab

    1980-01-01

    The magnetic horn, focusing the antiprotons emanating from the target, was affixed to a sandwich line through which the 150 kA pulses were supplied. Expecting to have to change from time to time the fragile horn (inner conductor only 0.7 mm thick), the assembly was designed for quick exchange. At the lower end of the sandwich line we see the connectors for the high-current cables, at the upper end the magnet horn. It has just been lifted from the V-supports which held it aligned downstream of the target. Continue with 8010293.

  18. FTA Corpus: a parallel corpus of English and Spanish Free Trade Agreements for the study of specialized collocations

    Directory of Open Access Journals (Sweden)

    Pedro Patiño García

    2013-04-01

    Full Text Available This paper describes the Corpus of Free Trade Agreements (henceforth FTA, a specialized parallel corpus in English and Spanish from Europe and America and a smaller subcorpus in English-Norwegian and Spanish-Norwegian that was prepared and then aligned with Translation Corpus Aligner 2 (Hofland & Johansson, 1998. The data was taken from Free Trade Agreements. These agreements are specialized texts officially signed and ratified by several countries and blocks of countries in the last twenty years. Thus, FTAs are a rich repository for terminology and phraseology that is used in different fields of business activity throughout the world. The corpus contains around 1.37 million words in the English section and 1.48 million words in its Spanish counterpart, plus 60,000 words each in the Spanish-Norwegian and English-Norwegian subcorpus. The corpus is being used primarily to study the terms and specialized collocations that include these terms in this kind of specialized texts.Keywords: specialized collocation, specialized parallel corpus, corpus linguistics, Free Trade Agreement

  19. Implementation of PHENIX trigger algorithms on massively parallel computers

    International Nuclear Information System (INIS)

    Petridis, A.N.; Wohn, F.K.

    1995-01-01

    The event selection requirements of contemporary high energy and nuclear physics experiments are met by the introduction of on-line trigger algorithms which identify potentially interesting events and reduce the data acquisition rate to levels that are manageable by the electronics. Such algorithms being parallel in nature can be simulated off-line using massively parallel computers. The PHENIX experiment intends to investigate the possible existence of a new phase of matter called the quark gluon plasma which has been theorized to have existed in very early stages of the evolution of the universe by studying collisions of heavy nuclei at ultra-relativistic energies. Such interactions can also reveal important information regarding the structure of the nucleus and mandate a thorough investigation of the simpler proton-nucleus collisions at the same energies. The complexity of PHENIX events and the need to analyze and also simulate them at rates similar to the data collection ones imposes enormous computation demands. This work is a first effort to implement PHENIX trigger algorithms on parallel computers and to study the feasibility of using such machines to run the complex programs necessary for the simulation of the PHENIX detector response. Fine and coarse grain approaches have been studied and evaluated. Depending on the application the performance of a massively parallel computer can be much better or much worse than that of a serial workstation. A comparison between single instruction and multiple instruction computers is also made and possible applications of the single instruction machines to high energy and nuclear physics experiments are outlined. copyright 1995 American Institute of Physics

  20. Scintillation counter: photomultiplier tube alignment

    International Nuclear Information System (INIS)

    Olson, R.E.

    1975-01-01

    A scintillation counter, particularly for counting gamma ray photons, includes a massive lead radiation shield surrounding a sample-receiving zone. The shield is disassembleable into a plurality of segments to allow facile installation and removal of a photomultiplier tube assembly, the segments being so constructed as to prevent straight-line access of external radiation through the shield into the sample receiving zone. Provisions are made for accurately aligning the photomultiplier tube with respect to one or more sample-transmitting bores extending through the shield to the sample receiving zone. A sample elevator, used in transporting samples into the zone, is designed to provide a maximum gamma-receiving aspect to maximize the gamma detecting efficiency. (auth)

  1. A new prosthetic alignment device to read and record prosthesis alignment data.

    Science.gov (United States)

    Pirouzi, Gholamhossein; Abu Osman, Noor Azuan; Ali, Sadeeq; Davoodi Makinejad, Majid

    2017-12-01

    Prosthetic alignment is an essential process to rehabilitate patients with amputations. This study presents, for the first time, an invented device to read and record prosthesis alignment data. The digital device consists of seven main parts: the trigger, internal shaft, shell, sensor adjustment button, digital display, sliding shell, and tip. The alignment data were read and recorded by the user or a computer to replicate prosthesis adjustment for future use or examine the sequence of changes in alignment and its effect on the posture of the patient. Alignment data were recorded at the anterior/posterior and medial/lateral positions for five patients. Results show the high level of confidence to record alignment data and replicate adjustments. Therefore, the device helps patients readjust their prosthesis by themselves, or prosthetists to perform adjustment for patients and analyze the effects of malalignment.

  2. Nanotopography induced contact guidance of the F11 cell line during neuronal differentiation: a neuronal model cell line for tissue scaffold development

    International Nuclear Information System (INIS)

    Wieringa, Paul; Micera, Silvestro; Tonazzini, Ilaria; Cecchini, Marco

    2012-01-01

    The F11 hybridoma, a dorsal root ganglion-derived cell line, was used to investigate the response of nociceptive sensory neurons to nanotopographical guidance cues. This established this cell line as a model of peripheral sensory neuron growth for tissue scaffold design. Cells were seeded on substrates of cyclic olefin copolymer (COC) films imprinted via nanoimprint lithography (NIL) with a grating pattern of nano-scale grooves and ridges. Different ridge widths were employed to alter the focal adhesion formation, thereby changing the cell/substrate interaction. Differentiation was stimulated with forskolin in culture medium consisting of either 1 or 10% fetal bovine serum (FBS). Per medium condition, similar neurite alignment was achieved over the four day period, with the 1% serum condition exhibiting longer, more aligned neurites. Immunostaining for focal adhesions found the 1% FBS condition to also have fewer, less developed focal adhesions. The robust response of the F11 to guidance cues further builds on the utility of this cell line as a sensory neuron model, representing a useful tool to explore the design of regenerative guidance tissue scaffolds. (paper)

  3. A parallel finite element procedure for contact-impact problems using edge-based smooth triangular element and GPU

    Science.gov (United States)

    Cai, Yong; Cui, Xiangyang; Li, Guangyao; Liu, Wenyang

    2018-04-01

    The edge-smooth finite element method (ES-FEM) can improve the computational accuracy of triangular shell elements and the mesh partition efficiency of complex models. In this paper, an approach is developed to perform explicit finite element simulations of contact-impact problems with a graphical processing unit (GPU) using a special edge-smooth triangular shell element based on ES-FEM. Of critical importance for this problem is achieving finer-grained parallelism to enable efficient data loading and to minimize communication between the device and host. Four kinds of parallel strategies are then developed to efficiently solve these ES-FEM based shell element formulas, and various optimization methods are adopted to ensure aligned memory access. Special focus is dedicated to developing an approach for the parallel construction of edge systems. A parallel hierarchy-territory contact-searching algorithm (HITA) and a parallel penalty function calculation method are embedded in this parallel explicit algorithm. Finally, the program flow is well designed, and a GPU-based simulation system is developed, using Nvidia's CUDA. Several numerical examples are presented to illustrate the high quality of the results obtained with the proposed methods. In addition, the GPU-based parallel computation is shown to significantly reduce the computing time.

  4. Altering graphene line defect properties using chemistry

    Science.gov (United States)

    Vasudevan, Smitha; White, Carter; Gunlycke, Daniel

    2012-02-01

    First-principles calculations are presented of a fundamental topological line defect in graphene that was observed and reported in Nature Nanotech. 5, 326 (2010). These calculations show that atoms and smaller molecules can bind covalently to the surface in the vicinity of the graphene line defect. It is also shown that the chemistry at the line defect has a strong effect on its electronic and magnetic properties, e.g. the ferromagnetically aligned moments along the line defect can be quenched by some adsorbates. The strong effect of the adsorbates on the line defect properties can be understood by examining how these adsorbates affect the boundary-localized states in the vicinity of the Fermi level. We also expect that the line defect chemistry will significantly affect the scattering properties of incident low-energy particles approaching it from graphene.

  5. Kinematic analysis and experimental verification of a eccentric wheel based precision alignment mechanism for LINAC

    International Nuclear Information System (INIS)

    Mundra, G.; Jain, V.; Singh, K.K.; Saxena, P.; Khare, R.K.; Bagre, M.

    2011-01-01

    Eccentric wheel based precision alignment system was designed for the remote motorized alignment of proposed proton injector LINAC (SFDTL). As a part of the further development for the alignment and monitoring scheme, a menu driven alignment system is being developed. The paper describes a general kinematic equation (with base line tilt correction) based on the various parameters of the mechanism like eccentricity, wheel diameter, distance between the wheels and the diameter of the cylindrical accelerator component. Based on this equation the extent of the alignment range for the 4 degree of freedom is evaluated and analysis on some of the parameters variation and the theoretical accuracy/resolution is computed. For the same a computer program is written which can compute the various points for the each discrete position of the two motor combinations. The paper also describes the experimentally evaluated values of these positions (for the full extent of area) and the matching/comparison of the two data. These data now can be used for the movement computation required for alignment of the four motors (two front and two rear motors of the support structure). (author)

  6. Engineering survey planning for the alignment of a particle accelerator: part I. Proposition of an assessment method

    Science.gov (United States)

    Junqueira Leão, Rodrigo; Raffaelo Baldo, Crhistian; Collucci da Costa Reis, Maria Luisa; Alves Trabanco, Jorge Luiz

    2018-03-01

    The performance of particle accelerators depends highly on the relative alignment between their components. The position and orientation of the magnetic lenses that form the trajectory of the charged beam is kept to micrometric tolerances in a range of hundreds of meters of the length of the machines. Therefore, the alignment problem is fundamentally of a dimensional metrology nature. There is no common way of expressing these tolerances in terms of terminology and alignment concept. The alignment needs for a certain machine is normally given in terms of deviations between the position of any magnet in the accelerator and the fitted line that relates the actual position of the magnets’ assembly. Root mean square errors and standard deviations are normally used interchangeably and measurement uncertainty is often neglected. Although some solutions have been employed successfully in several accelerators, there is no off-the-shelf solution to perform the alignment. Also, each alignment campaign makes use of different measuring instruments to achieve the desired results, which makes the alignment process a complex measurement chain. This paper explores these issues by reviewing the tolerances specified for the alignment of particle accelerators, and proposes a metric to assess the quality of the alignment. The metric has the advantage of fully integrating the measurement uncertainty in the process.

  7. Effects of variable attachment shapes and aligner material on aligner retention.

    Science.gov (United States)

    Dasy, Hiltrud; Dasy, Andreas; Asatrian, Greg; Rózsa, Noémi; Lee, Hao-Fu; Kwak, Jin Hee

    2015-11-01

    To evaluate the retention of four types of aligners on a dental arch with various attachments. For this study, three casts were manufactured, two of which contained attachments (ellipsoid and beveled), and one without any attachments to serve as a control. Four types of aligners were thermoformed: Clear-Aligner (CA)-soft, CA-medium, and CA-hard, with various thicknesses, and Essix ACE. Measurements of vertical displacement force during aligner removal were performed with the Gabo Qualimeter Eplexor. Means and standard deviations were next compared between different aligner thicknesses and attachment shapes. CA-soft, CA-medium, and CA-hard did not present a significant increase in retention, except when used in the presence of attachments. Additionally, CA-medium and CA-hard required significantly more force for removal. Essix ACE demonstrated a significant decrease in retention when used with ellipsoid attachments. The force value for Essix ACE removal from the cast with beveled attachments was comparable to that of CA-medium. Forces for aligner removal from the model without attachments showed a linear trend. Essix ACE did not show a continuous increase in retention for each model. Overall, ellipsoid attachments did not present a significant change in retention. In contrast, beveled attachments improved retention. Ellipsoid attachments had no significant influence on the force required for aligner removal and hence on aligner retention. Essix ACE showed significantly less retention than CA-hard on the models with attachments. Furthermore, beveled attachments were observed to increase retention significantly, compared with ellipsoid attachments and when using no attachments.

  8. Analysis of Relative Parallelism Between Hamular-Incisive-Papilla Plane and Campers Plane in Edentulous Subjects: A Comparative Study.

    Science.gov (United States)

    Tambake, Deepti; Shetty, Shilpa; Satish Babu, C L; Fulari, Sangamesh G

    2014-12-01

    The study was undertaken to evaluate the parallelism between hamular-incisive-papilla plane (HIP) and the Campers plane. And to determine which part of the posterior reference of the tragus i.e., the superior, middle or the inferior of the Camper's plane is parallel to HIP using digital lateral cephalograms. Fifty edentulous subjects with well formed ridges were selected for the study. The master casts were obtained using the standard selective pressure impression procedure. On the deepest point of the hamular notches and the centre of the incisive papilla stainless steel spherical bearings were glued to the cast at the marked points. The study templates were fabricated with autopolymerizing acrylic resin. The subjects were prepared for the lateral cephalograms. Stainless steel spherical bearings were adhered to the superior, middle, inferior points of the tragus of the ear and inferior border of the ala of the nose using surgical adhesive tape. The subjects with study templates were subjected to lateral cephalograms. Cephalometric tracings were done using Autocad 2010 software. Lines were drawn connecting the incisive papilla and hamular notch and the stainless steel spherical bearings placed on the superior, middle and inferior points on the tragus and the ala of the nose i.e., the Campers line S, Campers line M, Campers line I. The angles between the three Camper's line and the HIP were measured and recorded. Higher mean angulation was recorded in Campers line S -HIP (8.03) followed by Campers line M-HIP (4.60). Campers line I-HIP recorded the least angulation (3.80). The HIP is parallel to the Camper's plane. The Camper's plane formed with the posterior reference point as inferior point of the tragus is relatively parallel to the HIP.

  9. UNVEILING A NETWORK OF PARALLEL FILAMENTS IN THE INFRARED DARK CLOUD G14.225-0.506

    Energy Technology Data Exchange (ETDEWEB)

    Busquet, Gemma [INAF-Istituto di Astrofisica e Planetologia Spaziali, via Fosso del Cavaliere 100, I-00133 Roma (Italy); Zhang, Qizhou; Ho, Paul T. P. [Harvard-Smithsonian Center for Astrophysics, 60 Garden Street, Cambridge, MA 02138 (United States); Palau, Aina; Girart, Josep M. [Institut de Ciencies de l' Espai (CSIC-IEEC), Campus UAB, Facultat de Ciencies, Torre C-5 parell, E-08193 Bellaterra, Catalunya (Spain); Liu, Hauyu Baobab [Academia Sinica Institute of Astronomy and Astrophysics, Taipei, Taiwan (China); Sanchez-Monge, Alvaro [INAF, Osservatorio Astrofisico di Arcetri, Largo E. Fermi 5, I-05125 Firenze (Italy); Estalella, Robert [Departament d' Astronomia i Meteorologia, Institut de Ciencies del Cosmos (ICC), Universitat de Barcelona (IEEC-UB), Marti i Franques 1, E-08028 Barcelona, Catalunya (Spain); De Gregorio-Monsalvo, Itziar [European Southern Observatory, Karl-Schwarzschild-Strasse 2, D-85748 Garching (Germany); Pillai, Thushara [Caltech Astronomy Department, MC 249-17, 1200 East California Boulevard, Pasadena, CA 91125 (United States); Wyrowski, Friedrich [Max-Planck-Institut fuer Radioastronomie, Auf dem Huegel 69, D-53121 Bonn (Germany); Santos, Fabio P.; Franco, Gabriel A. P., E-mail: gemma.busquet@iaps.inaf.it [Departamento de Fisica-ICEx-UFMG, Caixa Postal 702, 30.123-970 Belo Horizonte-MG (Brazil)

    2013-02-20

    We present the results of combined NH{sub 3} (1,1) and (2,2) line emission observed with the Very Large Array and the Effelsberg 100 m telescope of the infrared dark cloud G14.225-0.506. The NH{sub 3} emission reveals a network of filaments constituting two hub-filament systems. Hubs are associated with gas of rotational temperature T{sub rot} {approx} 15 K, non-thermal velocity dispersion {sigma}{sub NT} {approx} 1 km s{sup -1}, and exhibit signs of star formation, while filaments appear to be more quiescent (T{sub rot} {approx} 11 K and {sigma}{sub NT} {approx} 0.6 km s{sup -1}). Filaments are parallel in projection and distributed mainly along two directions, at P.A. {approx} 10 Degree-Sign and 60 Degree-Sign , and appear to be coherent in velocity. The averaged projected separation between adjacent filaments is between 0.5 pc and 1 pc, and the mean width of filaments is 0.12 pc. Cores within filaments are separated by {approx}0.33 {+-} 0.09 pc, which is consistent with the predicted fragmentation of an isothermal gas cylinder due to the {sup s}ausage{sup -}type instability. The network of parallel filaments observed in G14.225-0.506 is consistent with the gravitational instability of a thin gas layer threaded by magnetic fields. Overall, our data suggest that magnetic fields might play an important role in the alignment of filaments, and polarization measurements in the entire cloud would lend further support to this scenario.

  10. Finite-difference schemes for anisotropic diffusion

    Energy Technology Data Exchange (ETDEWEB)

    Es, Bram van, E-mail: es@cwi.nl [Centrum Wiskunde and Informatica, P.O. Box 94079, 1090GB Amsterdam (Netherlands); FOM Institute DIFFER, Dutch Institute for Fundamental Energy Research, Association EURATOM-FOM (Netherlands); Koren, Barry [Eindhoven University of Technology (Netherlands); Blank, Hugo J. de [FOM Institute DIFFER, Dutch Institute for Fundamental Energy Research, Association EURATOM-FOM (Netherlands)

    2014-09-01

    In fusion plasmas diffusion tensors are extremely anisotropic due to the high temperature and large magnetic field strength. This causes diffusion, heat conduction, and viscous momentum loss, to effectively be aligned with the magnetic field lines. This alignment leads to different values for the respective diffusive coefficients in the magnetic field direction and in the perpendicular direction, to the extent that heat diffusion coefficients can be up to 10{sup 12} times larger in the parallel direction than in the perpendicular direction. This anisotropy puts stringent requirements on the numerical methods used to approximate the MHD-equations since any misalignment of the grid may cause the perpendicular diffusion to be polluted by the numerical error in approximating the parallel diffusion. Currently the common approach is to apply magnetic field-aligned coordinates, an approach that automatically takes care of the directionality of the diffusive coefficients. This approach runs into problems at x-points and at points where there is magnetic re-connection, since this causes local non-alignment. It is therefore useful to consider numerical schemes that are tolerant to the misalignment of the grid with the magnetic field lines, both to improve existing methods and to help open the possibility of applying regular non-aligned grids. To investigate this, in this paper several discretization schemes are developed and applied to the anisotropic heat diffusion equation on a non-aligned grid.

  11. Dislocation mediated alignment during metal nanoparticle coalescence

    International Nuclear Information System (INIS)

    Lange, A.P.; Samanta, A.; Majidi, H.; Mahajan, S.; Ging, J.; Olson, T.Y.; Benthem, K. van; Elhadj, S.

    2016-01-01

    Dislocation mediated alignment processes during gold nanoparticle coalescence were studied at low and high temperatures using molecular dynamics simulations and transmission electron microscopy. Particles underwent rigid body rotations immediately following attachment in both low temperature (500 K) simulated coalescence events and low temperature (∼315 K) transmission electron microscopy beam heating experiments. In many low temperature simulations, some degree of misorientation between particles remained after rigid body rotations, which was accommodated by grain boundary dislocation nodes. These dislocations were either sessile and remained at the interface for the duration of the simulation or dissociated and cross-slipped through the adjacent particles, leading to improved co-alignment. Minimal rigid body rotations were observed during or immediately following attachment in high temperature (1100 K) simulations, which is attributed to enhanced diffusion at the particles' interface. However, rotation was eventually induced by {111} slip on planes parallel to the neck groove. These deformation modes led to the formation of single and multi-fold twins whose structures depended on the initial orientation of the particles. The driving force for {111} slip is attributed to high surface stresses near the intersection of low energy {111} facets in the neck region. The details of this twinning process were examined in detail using simulated trajectories, and the results reveal possible mechanisms for the nucleation and propagation of Shockley partials on consecutive planes. Deformation twinning was also observed in-situ using transmission electron microscopy, which resulted in the co-alignment of a set of the particles' {111} planes across their grain boundary and an increase in their dihedral angle. This constitutes the first detailed experimental observation of deformation twinning during nanoparticle coalescence, validating simulation results presented here and

  12. GraphCrunch 2: Software tool for network modeling, alignment and clustering.

    Science.gov (United States)

    Kuchaiev, Oleksii; Stevanović, Aleksandar; Hayes, Wayne; Pržulj, Nataša

    2011-01-19

    Recent advancements in experimental biotechnology have produced large amounts of protein-protein interaction (PPI) data. The topology of PPI networks is believed to have a strong link to their function. Hence, the abundance of PPI data for many organisms stimulates the development of computational techniques for the modeling, comparison, alignment, and clustering of networks. In addition, finding representative models for PPI networks will improve our understanding of the cell just as a model of gravity has helped us understand planetary motion. To decide if a model is representative, we need quantitative comparisons of model networks to real ones. However, exact network comparison is computationally intractable and therefore several heuristics have been used instead. Some of these heuristics are easily computable "network properties," such as the degree distribution, or the clustering coefficient. An important special case of network comparison is the network alignment problem. Analogous to sequence alignment, this problem asks to find the "best" mapping between regions in two networks. It is expected that network alignment might have as strong an impact on our understanding of biology as sequence alignment has had. Topology-based clustering of nodes in PPI networks is another example of an important network analysis problem that can uncover relationships between interaction patterns and phenotype. We introduce the GraphCrunch 2 software tool, which addresses these problems. It is a significant extension of GraphCrunch which implements the most popular random network models and compares them with the data networks with respect to many network properties. Also, GraphCrunch 2 implements the GRAph ALigner algorithm ("GRAAL") for purely topological network alignment. GRAAL can align any pair of networks and exposes large, dense, contiguous regions of topological and functional similarities far larger than any other existing tool. Finally, GraphCruch 2 implements an

  13. GraphCrunch 2: Software tool for network modeling, alignment and clustering

    Directory of Open Access Journals (Sweden)

    Hayes Wayne

    2011-01-01

    Full Text Available Abstract Background Recent advancements in experimental biotechnology have produced large amounts of protein-protein interaction (PPI data. The topology of PPI networks is believed to have a strong link to their function. Hence, the abundance of PPI data for many organisms stimulates the development of computational techniques for the modeling, comparison, alignment, and clustering of networks. In addition, finding representative models for PPI networks will improve our understanding of the cell just as a model of gravity has helped us understand planetary motion. To decide if a model is representative, we need quantitative comparisons of model networks to real ones. However, exact network comparison is computationally intractable and therefore several heuristics have been used instead. Some of these heuristics are easily computable "network properties," such as the degree distribution, or the clustering coefficient. An important special case of network comparison is the network alignment problem. Analogous to sequence alignment, this problem asks to find the "best" mapping between regions in two networks. It is expected that network alignment might have as strong an impact on our understanding of biology as sequence alignment has had. Topology-based clustering of nodes in PPI networks is another example of an important network analysis problem that can uncover relationships between interaction patterns and phenotype. Results We introduce the GraphCrunch 2 software tool, which addresses these problems. It is a significant extension of GraphCrunch which implements the most popular random network models and compares them with the data networks with respect to many network properties. Also, GraphCrunch 2 implements the GRAph ALigner algorithm ("GRAAL" for purely topological network alignment. GRAAL can align any pair of networks and exposes large, dense, contiguous regions of topological and functional similarities far larger than any other

  14. Mask alignment system for semiconductor processing

    Science.gov (United States)

    Webb, Aaron P.; Carlson, Charles T.; Weaver, William T.; Grant, Christopher N.

    2017-02-14

    A mask alignment system for providing precise and repeatable alignment between ion implantation masks and workpieces. The system includes a mask frame having a plurality of ion implantation masks loosely connected thereto. The mask frame is provided with a plurality of frame alignment cavities, and each mask is provided with a plurality of mask alignment cavities. The system further includes a platen for holding workpieces. The platen may be provided with a plurality of mask alignment pins and frame alignment pins configured to engage the mask alignment cavities and frame alignment cavities, respectively. The mask frame can be lowered onto the platen, with the frame alignment cavities moving into registration with the frame alignment pins to provide rough alignment between the masks and workpieces. The mask alignment cavities are then moved into registration with the mask alignment pins, thereby shifting each individual mask into precise alignment with a respective workpiece.

  15. Field-aligned currents during northward interplanetary magnetic field: Morphology and causes

    DEFF Research Database (Denmark)

    Vennerstrøm, Susanne; Moretto, T.; Rastatter, L.

    2005-01-01

    [1] We present the results of a global MHD simulation of solar wind magnetosphere interaction during northward IMF. In particular, we emphasize the effect of the IMF By component on the reconnection geometry and the mapping along field lines to the polar ionosphere, through field-aligned currents....... We find that the existence and geometry of the polar cap is closely connected to the IMF By component. During strictly northward IMF the simulated magnetosphere can remain essentially closed because the solar wind field lines reconnect in both hemispheres, thereby creating newly reconnected closed...... both on open and closed field lines and are created by the shear of the newly reconnected field lines against the mantle field as they are convected tailward by the solar wind. When the IMF rotates from northward toward east, the magnetospheric mapping regions of the NBZ currents likewise rotates...

  16. Self-optimizing approach for automated laser resonator alignment

    Science.gov (United States)

    Brecher, C.; Schmitt, R.; Loosen, P.; Guerrero, V.; Pyschny, N.; Pavim, A.; Gatej, A.

    2012-02-01

    Nowadays, the assembly of laser systems is dominated by manual operations, involving elaborate alignment by means of adjustable mountings. From a competition perspective, the most challenging problem in laser source manufacturing is price pressure, a result of cost competition exerted mainly from Asia. From an economical point of view, an automated assembly of laser systems defines a better approach to produce more reliable units at lower cost. However, the step from today's manual solutions towards an automated assembly requires parallel developments regarding product design, automation equipment and assembly processes. This paper introduces briefly the idea of self-optimizing technical systems as a new approach towards highly flexible automation. Technically, the work focuses on the precision assembly of laser resonators, which is one of the final and most crucial assembly steps in terms of beam quality and laser power. The paper presents a new design approach for miniaturized laser systems and new automation concepts for a robot-based precision assembly, as well as passive and active alignment methods, which are based on a self-optimizing approach. Very promising results have already been achieved, considerably reducing the duration and complexity of the laser resonator assembly. These results as well as future development perspectives are discussed.

  17. Status report on the alignment activities at SLAC

    International Nuclear Information System (INIS)

    Le Cocq, Catherine; Fuss, Brian; Ruland, Robert

    2003-01-01

    This report mainly focuses on the Alignment Engineering Group, which deals with all aspects of activities involving surveying and alignment at SLAC (Stanford Linear Accelerator Center). These activities are field work, ongoing studies and mapping effort. The majority of fieldwork at SLAC is initiated by the various current physics experiments. As PEP-II switched into operational mode, another major project was fully ramping up: SPEAR. The Stanford Synchrotron Radiation Laboratory (SSRL) had been preparing the upgrade SPEAR3 (3 GeV, 200 mA). Currently the effort has been to remap the entire SPEAR2 ring including existing magnets but also to map and tie in the connected booster ring. Laser trackers, total stations, and digital levels were used and substantial post processing was necessary to tie everything together. In parallel with field works, several instrumentation studies are in progress on laser tracker and total station, leveling instrumentation and gyro theodolites. Further enhancements have been included in the core network analysis package used at SLAC (LEGO). To keep up with the new installation, SLAC is undergoing an update of its site map. Overall this is a very interesting and dynamic time at SLAC, which celebrated its 40th anniversary on October 2nd 2002. (Y. Tanaka)

  18. Flexbar 3.0 - SIMD and multicore parallelization.

    Science.gov (United States)

    Roehr, Johannes T; Dieterich, Christoph; Reinert, Knut

    2017-09-15

    High-throughput sequencing machines can process many samples in a single run. For Illumina systems, sequencing reads are barcoded with an additional DNA tag that is contained in the respective sequencing adapters. The recognition of barcode and adapter sequences is hence commonly needed for the analysis of next-generation sequencing data. Flexbar performs demultiplexing based on barcodes and adapter trimming for such data. The massive amounts of data generated on modern sequencing machines demand that this preprocessing is done as efficiently as possible. We present Flexbar 3.0, the successor of the popular program Flexbar. It employs now twofold parallelism: multi-threading and additionally SIMD vectorization. Both types of parallelism are used to speed-up the computation of pair-wise sequence alignments, which are used for the detection of barcodes and adapters. Furthermore, new features were included to cover a wide range of applications. We evaluated the performance of Flexbar based on a simulated sequencing dataset. Our program outcompetes other tools in terms of speed and is among the best tools in the presented quality benchmark. https://github.com/seqan/flexbar. johannes.roehr@fu-berlin.de or knut.reinert@fu-berlin.de. © The Author (2017). Published by Oxford University Press. All rights reserved. For Permissions, please email: journals.permissions@oup.com

  19. A Trajectory Correction based on Multi-Step Lining-up for the CLIC Main Linac

    CERN Document Server

    D'Amico, T E

    1999-01-01

    In the CLIC main linac it is very important to minimise the trajectory excursion and consequently the emittance dilution in order to obtain the required luminosity. Several algorithms have been proposed and lately the ballistic method has proved to be very effective. The trajectory method described in this Note retains the main advantages of the latter while adding some interesting features. It is based on the separation of the unknown variables like the quadrupole misalignments, the offset and slope of the injection straight line and the misalignments of the beam position monitors (BPM). This is achieved by referring the trajectory relatively to the injection line and not to the average pre-alignment line and by using two trajectories each corresponding to slightly different quadrupole strengths. A reference straight line is then derived onto which the beam is bent by a kick obtained by moving the first quadrupole. The other quadrupoles are then aligned on that line. The quality of the correction depends mai...

  20. Massively parallel algorithms for trace-driven cache simulations

    Science.gov (United States)

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

    1991-01-01

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

  1. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    M. Dallavalle

    2013-01-01

    A new Muon misalignment scenario for 2011 (7 TeV) Monte Carlo re-processing was re-leased. The scenario is based on running of standard track-based reference-target algorithm (exactly as in data) using single-muon simulated sample (with the transverse-momentum spectrum matching data). It used statistics similar to what was used for alignment with 2011 data, starting from an initially misaligned Muon geometry from uncertainties of hardware measurements and using the latest Tracker misalignment geometry. Validation of the scenario (with muons from Z decay and high-pT simulated muons) shows that it describes data well. The study of systematic uncertainties (dominant by now due to huge amount of data collected by CMS and used for muon alignment) is finalised. Realistic alignment position errors are being obtained from the estimated uncertainties and are expected to improve the muon reconstruction performance. Concerning the Hardware Alignment System, the upgrade of the Barrel Alignment is in progress. By now, d...

  2. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez

    2011-01-01

    A new set of muon alignment constants was approved in August. The relative position between muon chambers is essentially unchanged, indicating good detector stability. The main changes concern the global positioning of the barrel and of the endcap rings to match the new Tracker geometry. Detailed studies of the differences between track-based and optical alignment of DTs have proven to be a valuable tool for constraining Tracker alignment weak modes, and this information is now being used as part of the alignment procedure. In addition to the “split-cosmic” analysis used to investigate the muon momentum resolution at high momentum, a new procedure based on reconstructing the invariant mass of di-muons from boosted Zs is under development. Both procedures show an improvement in the momentum precision of Global Muons with respect to Tracker-only Muons. Recent developments in track-based alignment include a better treatment of the tails of residual distributions and accounting for correla...

  3. Characterization and performance of a field aligned ion cyclotron range of frequency antenna in Alcator C-Moda)

    Science.gov (United States)

    Wukitch, S. J.; Garrett, M. L.; Ochoukov, R.; Terry, J. L.; Hubbard, A.; Labombard, B.; Lau, C.; Lin, Y.; Lipschultz, B.; Miller, D.; Reinke, M. L.; Whyte, D.; Alcator C-Mod Team

    2013-05-01

    Ion cyclotron range of frequency (ICRF) heating is expected to provide auxiliary heating for ITER and future fusion reactors where high Z metallic plasma facing components (PFCs) are being considered. Impurity contamination linked to ICRF antenna operation remains a major challenge particularly for devices with high Z metallic PFCs. Here, we report on an experimental investigation to test whether a field aligned (FA) antenna can reduce impurity contamination and impurity sources. We compare the modification of the scrape of layer (SOL) plasma potential of the FA antenna to a conventional, toroidally aligned (TA) antenna, in order to explore the underlying physics governing impurity contamination linked to ICRF heating. The FA antenna is a 4-strap ICRF antenna where the current straps and antenna enclosure sides are perpendicular to the total magnetic field while the Faraday screen rods are parallel to the total magnetic field. In principle, alignment with respect to the total magnetic field minimizes integrated E|| (electric field along a magnetic field line) via symmetry. A finite element method RF antenna model coupled to a cold plasma model verifies that the integrated E|| should be reduced for all antenna phases. Monopole phasing in particular is expected to have the lowest integrated E||. Consistent with expectations, we observed that the impurity contamination and impurity source at the FA antenna are reduced compared to the TA antenna. In both L and H-mode discharges, the radiated power is 20%-30% lower for a FA-antenna heated discharge than a discharge heated with the TA-antennas. However, inconsistent with expectations, we observe RF induced plasma potentials (via gas-puff imaging and emissive probes to be nearly identical for FA and TA antennas when operated in dipole phasing). Moreover, the highest levels of RF-induced plasma potentials are observed using monopole phasing with the FA antenna. Thus, while impurity contamination and sources are indeed

  4. Identification and characterization of mobile genetic elements LINEs from Brassica genome.

    Science.gov (United States)

    Nouroz, Faisal; Noreen, Shumaila; Khan, Muhammad Fiaz; Ahmed, Shehzad; Heslop-Harrison, J S Pat

    2017-09-05

    Among transposable elements (TEs), the LTR retrotransposons are abundant followed by non-LTR retrotransposons in plant genomes, the lateral being represented by LINEs and SINEs. Computational and molecular approaches were used for the characterization of Brassica LINEs, their diversity and phylogenetic relationships. Four autonomous and four non-autonomous LINE families were identified and characterized from Brassica. Most of the autonomous LINEs displayed two open reading frames, ORF1 and ORF2, where ORF1 is a gag protein domain, while ORF2 encodes endonuclease (EN) and a reverse transcriptase (RT). Three of four families encoded an additional RNase H (RH) domain in pol gene common to 'R' and 'I' type of LINEs. The PCR analyses based on LINEs RT fragments indicate their high diversity and widespread occurrence in tested 40 Brassica cultivars. Database searches revealed the homology in LINE sequences in closely related genera Arabidopsis indicating their origin from common ancestors predating their separation. The alignment of 58 LINEs RT sequences from Brassica, Arabidopsis and other plants depicted 4 conserved domains (domain II-V) showing similarity to previously detected domains. Based on RT alignment of Brassica and 3 known LINEs from monocots, Brassicaceae LINEs clustered in separate clade, further resolving 4 Brassica-Arabidopsis specific families in 2 sub-clades. High similarities were observed in RT sequences in the members of same family, while low homology was detected in members across the families. The investigation led to the characterization of Brassica specific LINE families and their diversity across Brassica species and their cultivars. Copyright © 2017 Elsevier B.V. All rights reserved.

  5. Field-aligned structure of the storm time Pc 5 wave of November 14-15, 1979

    International Nuclear Information System (INIS)

    Takahashi, K.; Higbie, P.R.; Fennell, J.F.; Amata, E.

    1987-01-01

    Magnetic field data from the four satellites SCATHA (P78-2), GOES 2, GOES 3, and GEOS 2 have been analyzed to examine the magnetic field-aligned structure of a storm time Pc 5 wave that occurred on November 14-15, 1979. The wave had both transverse and compressional components. At a given instance the compressional and the radial components oscillated in phase of 180 degree out of phase, and the compressional and the azimuthal components oscillated +90 degree or -90 degree out of phase. In addition, each component changed its amplitude with magnetic latitude: the compressional component had a minimum at the magnetic equator, whereas the transverse components had a maximum at the equator and minima several degrees off the equator. A 180 degree relative phase switching among the components occurred across the latitudes of amplitude minima. From these observations the field line displacement of the wave is confirmed to have an antisymmetric standing structure about the magnetic equator with a parallel wave length of a few earth radii. The authors also observed other intriguing properties of the wave such as different parallel wave lengths of different field components and small-amplitude second harmonics near the nodes. A dielectric tensor appropriate for the ring current plasma is found to give an explanation for the relation between the polarization and the propagation of the wave. However, plasma data available from SCATHA does not support either the drift mirror instability of A. Hasegawa (1969) or the coupling between a drift mirror wave and a shear Alfven wave as discussed by A.D.M. Walker et al. (1982)

  6. Tidal alignment of galaxies

    Energy Technology Data Exchange (ETDEWEB)

    Blazek, Jonathan; Vlah, Zvonimir; Seljak, Uroš

    2015-08-01

    We develop an analytic model for galaxy intrinsic alignments (IA) based on the theory of tidal alignment. We calculate all relevant nonlinear corrections at one-loop order, including effects from nonlinear density evolution, galaxy biasing, and source density weighting. Contributions from density weighting are found to be particularly important and lead to bias dependence of the IA amplitude, even on large scales. This effect may be responsible for much of the luminosity dependence in IA observations. The increase in IA amplitude for more highly biased galaxies reflects their locations in regions with large tidal fields. We also consider the impact of smoothing the tidal field on halo scales. We compare the performance of this consistent nonlinear model in describing the observed alignment of luminous red galaxies with the linear model as well as the frequently used "nonlinear alignment model," finding a significant improvement on small and intermediate scales. We also show that the cross-correlation between density and IA (the "GI" term) can be effectively separated into source alignment and source clustering, and we accurately model the observed alignment down to the one-halo regime using the tidal field from the fully nonlinear halo-matter cross correlation. Inside the one-halo regime, the average alignment of galaxies with density tracers no longer follows the tidal alignment prediction, likely reflecting nonlinear processes that must be considered when modeling IA on these scales. Finally, we discuss tidal alignment in the context of cosmic shear measurements.

  7. Fast global sequence alignment technique

    KAUST Repository

    Bonny, Mohamed Talal; Salama, Khaled N.

    2011-01-01

    fast alignment algorithm, called 'Alignment By Scanning' (ABS), to provide an approximate alignment of two DNA sequences. We compare our algorithm with the wellknown sequence alignment algorithms, the 'GAP' (which is heuristic) and the 'Needleman

  8. User-friendly parallelization of GAUDI applications with Python

    International Nuclear Information System (INIS)

    Mato, Pere; Smith, Eoin

    2010-01-01

    GAUDI is a software framework in C++ used to build event data processing applications using a set of standard components with well-defined interfaces. Simulation, high-level trigger, reconstruction, and analysis programs used by several experiments are developed using GAUDI. These applications can be configured and driven by simple Python scripts. Given the fact that a considerable amount of existing software has been developed using serial methodology, and has existed in some cases for many years, implementation of parallelisation techniques at the framework level may offer a way of exploiting current multi-core technologies to maximize performance and reduce latencies without re-writing thousands/millions of lines of code. In the solution we have developed, the parallelization techniques are introduced to the high level Python scripts which configure and drive the applications, such that the core C++ application code requires no modification, and that end users need make only minimal changes to their scripts. The developed solution leverages from existing generic Python modules that support parallel processing. Naturally, the parallel version of a given program should produce results consistent with its serial execution. The evaluation of several prototypes incorporating various parallelization techniques are presented and discussed.

  9. User-friendly parallelization of GAUDI applications with Python

    Energy Technology Data Exchange (ETDEWEB)

    Mato, Pere; Smith, Eoin, E-mail: pere.mato@cern.c [PH Department, CERN, 1211 Geneva 23 (Switzerland)

    2010-04-01

    GAUDI is a software framework in C++ used to build event data processing applications using a set of standard components with well-defined interfaces. Simulation, high-level trigger, reconstruction, and analysis programs used by several experiments are developed using GAUDI. These applications can be configured and driven by simple Python scripts. Given the fact that a considerable amount of existing software has been developed using serial methodology, and has existed in some cases for many years, implementation of parallelisation techniques at the framework level may offer a way of exploiting current multi-core technologies to maximize performance and reduce latencies without re-writing thousands/millions of lines of code. In the solution we have developed, the parallelization techniques are introduced to the high level Python scripts which configure and drive the applications, such that the core C++ application code requires no modification, and that end users need make only minimal changes to their scripts. The developed solution leverages from existing generic Python modules that support parallel processing. Naturally, the parallel version of a given program should produce results consistent with its serial execution. The evaluation of several prototypes incorporating various parallelization techniques are presented and discussed.

  10. Flow-driven alignment of carbon nanotubes during floating evaporative self assembly

    Science.gov (United States)

    Berson, Arganthael; Jinkins, Katherine; Chan, Jason; Brady, Gerald; Gronski, Kjerstin; Gopalan, Padma; Evensen, Harold; Arnold, Michael

    2017-11-01

    Individual semi-conducting single-wall carbon nanotubes (s-SWCNTs) exhibit exceptional electronic properties, which makes them promising candidates for the next generation of semi-conductor electronics. In practice, field-effect transistors (FETs) are fabricated from arrays of s-SWCNTs deposited onto a substrate. In order to achieve high electronic performance, the s-SWCNTs in these arrays must be densely packed and well aligned. Floating Evaporative Self Assembly (FESA) is a new deposition technique developed at the UW-Madison that can achieve such high-quality s-SWCNT alignment. For example, it was used to fabricate the first s-SWCNT-based FETs to outperform gallium arsenide and silicon FETs. In FESA, a droplet of ink containing the s-SWCNTs is deposited onto a pool of water. The ink spreads on the water surface towards a substrate that is vertically pulled out of the water. A band of aligned s-SWCNTs is deposited with each drop of ink. High-speed imaging is combined with cross-polarized microscopy to elucidate the mechanisms behind the exceptional alignment of s-SWCNTs. Two key mechanisms are 1) the collection of s-SWCNTs at the ink-water interface and 2) the depinning of the air-ink-substrate contact line. Avenues for scaling up FESA will be presented.

  11. Reduction of momentum transfer rates by parallel electric fields: A two-fluid demonstration

    International Nuclear Information System (INIS)

    Delamere, P.A.; Stenbaek-Nielsen, H.C.; Otto, A.

    2002-01-01

    Momentum transfer between an ionized gas cloud moving relative to an ambient magnetized plasma is a general problem in space plasma physics. Obvious examples include the Io-Jupiter interaction, comets, and coronal mass ejections. Active plasma experiments have demonstrated that momentum transfer rates associated with Alfven wave propagation are poorly understood. Barium injection experiments from the Combined Release and Radiation Effects Satellite (CRRES) have shown that dense ionized clouds are capable of ExB drifting over large distances perpendicular to the magnetic field. The CRRES 'skidding' distances were much larger than predicted by magnetohydrodynamic theory and it has been proposed that parallel electric fields were a key component in the skidding phenomenon. A two-fluid code was used to demonstrate the role of parallel electric fields in reducing momentum transfer between two distinct plasma populations. In this study, a dense plasma was initialized moving relative to an ambient plasma and perpendicular to B. Parallel electric fields were introduced via a friction term in the electron momentum equation and the collision frequency was scaled in proportion to the field-aligned current density. The simulation results showed that parallel electric fields decreased the decelerating magnetic tension force on the plasma cloud through a magnetic diffusion/reconnection process

  12. Precision crystal alignment for high-resolution electron microscope imaging

    International Nuclear Information System (INIS)

    Wood, G.J.; Beeching, M.J.

    1990-01-01

    One of the more difficult tasks involved in obtaining quality high-resolution electron micrographs is the precise alignment of a specimen into the required zone. The current accepted procedure, which involves changing to diffraction mode and searching for symmetric point diffraction pattern, is insensitive to small amounts of misalignment and at best qualitative. On-line analysis of the fourier space representation of the image, both for determining and correcting crystal tilt, is investigated. 8 refs., 42 figs

  13. Characterization of DNA repair phenotypes of Xeroderma pigmentosum cell lines by a paralleled in vitro test

    International Nuclear Information System (INIS)

    Raffin, A.L.

    2009-06-01

    DNA is constantly damaged modifying the genetic information for which it encodes. Several cellular mechanisms as the Base Excision Repair (BER) and the Nucleotide Excision Repair (NER) allow recovering the right DNA sequence. The Xeroderma pigmentosum is a disease characterised by a deficiency in the NER pathway. The aim of this study was to propose an efficient and fast test for the diagnosis of this disease as an alternative to the currently available UDS test. DNA repair activities of XP cell lines were quantified using in vitro miniaturized and paralleled tests in order to establish DNA repair phenotypes of XPA and XPC deficient cells. The main advantage of the tests used in this study is the simultaneous measurement of excision or excision synthesis (ES) of several lesions by only one cellular extract. We showed on one hand that the relative ES of the different lesions depend strongly on the protein concentration of the nuclear extract tested. Working at high protein concentration allowed discriminating the XP phenotype versus the control one, whereas it was impossible under a certain concentration's threshold. On the other hand, while the UVB irradiation of control cells stimulated their repair activities, this effect was not observed in XP cells. This study brings new information on the XPA and XPC protein roles during BER and NER and underlines the complexity of the regulations of DNA repair processes. (author)

  14. Low-cost optical interconnect module for parallel optical data links

    Science.gov (United States)

    Noddings, Chad; Hirsch, Tom J.; Olla, M.; Spooner, C.; Yu, Jason J.

    1995-04-01

    We have designed, fabricated, and tested a prototype parallel ten-channel unidirectional optical data link. When scaled to production, we project that this technology will satisfy the following market penetration requirements: (1) up to 70 meters transmission distance, (2) at least 1 gigabyte/second data rate, and (3) 0.35 to 0.50 MByte/second volume selling price. These goals can be achieved by means of the assembly innovations described in this paper: a novel alignment method that is integrated with low-cost, few chip module packaging techniques, yielding high coupling and reducing the component count. Furthermore, high coupling efficiency increases projected reliability reducing the driver's power requirements.

  15. Parallel Programming with Intel Parallel Studio XE

    CERN Document Server

    Blair-Chappell , Stephen

    2012-01-01

    Optimize code for multi-core processors with Intel's Parallel Studio Parallel programming is rapidly becoming a "must-know" skill for developers. Yet, where to start? This teach-yourself tutorial is an ideal starting point for developers who already know Windows C and C++ and are eager to add parallelism to their code. With a focus on applying tools, techniques, and language extensions to implement parallelism, this essential resource teaches you how to write programs for multicore and leverage the power of multicore in your programs. Sharing hands-on case studies and real-world examples, the

  16. Evaluation of Distal Femoral Rotational Alignment with Spiral CT Scan before Total Knee Arthroplasty (A Study in Iranian Population

    Directory of Open Access Journals (Sweden)

    Mahmoud Jabalameli

    2016-04-01

    Full Text Available Background: Evaluating the landmarks for rotation of the distal femur is a challenge for orthopedic surgeons. Although the posterior femoral condyle axis is a good landmark for surgeons, the surgical transepicondylar axis may be a better option with the help of preoperative CT scanning. The purpose of this study was to ascertain relationships among the axes’ guiding distal femur rotational alignment in preoperative CT scans of Iranian patients who were candidates for total knee arthroplasty and the effects of age, gender, and knee alignment on these relationships. Methods: One hundred and eight cases who were admitted to two university hospitals for total knee arthroplasty were included in this study. The rotation of the distal femur was evaluated using single axial CT images through the femoral epicondyle. Four lines were drawn digitally in this view: anatomical and surgical transepicondylar axes, posterior condylar axis and the Whiteside anteroposterior line. The alignment of the extremity was evaluated in the standing alignment view. Then the angles were measured along these lines and their relationship was evaluated. Results: The mean angle between the anatomical transepicondylar axis and posterior condylar axis and between the surgical transepicondylar axis and posterior condylar axis were 5.9 ± 1.6 degrees and 1.6±1.7 degrees respectively. The mean angle between the Whiteside’s anteroposterior line and the line perpendicular to the posterior condylar axis was 3.7±2.1 degrees. Significant differences existed between the two genders in these relationships. No significant correlation between the age of patients and angles of the distal femur was detected. The anatomical surgical transepicondylar axis was in 4.3 degrees external rotation in relation to the surgical transepicondylar axis. Conclusion: Preoperative CT scanning can help accurately determine rotational landmarks of the distal femur. If one of the reference axes cannot be

  17. He II lines in the spectrum of zeta Puppis

    International Nuclear Information System (INIS)

    Snijders, M.A.J.; Underhill, A.B.

    1975-01-01

    Equivalents widths of He II lines in the series n=2,3,4 and 5 are compiled and compared with predictions from plane-parallel, static model atmospheres using a non-LTE theory of line formation. The agreement between observation and prediction for a (50,000,4.0) model atmosphere is good for the upper members of the n=3 and the n=5 series, but the two lines of the n=2 series which are observed and the upper members of the n=4 series (4→15,4→17, etc.) are stronger than predicted. Well-determined profiles of lines from the n=3 series indicate v sin i=200 km s -1 . Profiles of the higher members of the n=4 series, however, do not match the predictions, the observed line cores being deeper than predicted. The n=4 level appears to be more overpopulated at moderate depths in the atmosphere than the non-LTE calculations with plane-parallel layers indicate. This may be due to an overlap of the H and He II lines in the even-even series caused by macroturbulent velocities of the hydrogen atoms and helium atoms

  18. UNVEILING A NETWORK OF PARALLEL FILAMENTS IN THE INFRARED DARK CLOUD G14.225–0.506

    International Nuclear Information System (INIS)

    Busquet, Gemma; Zhang, Qizhou; Ho, Paul T. P.; Palau, Aina; Girart, Josep M.; Liu, Hauyu Baobab; Sánchez-Monge, Álvaro; Estalella, Robert; De Gregorio-Monsalvo, Itziar; Pillai, Thushara; Wyrowski, Friedrich; Santos, Fábio P.; Franco, Gabriel A. P.

    2013-01-01

    We present the results of combined NH 3 (1,1) and (2,2) line emission observed with the Very Large Array and the Effelsberg 100 m telescope of the infrared dark cloud G14.225–0.506. The NH 3 emission reveals a network of filaments constituting two hub-filament systems. Hubs are associated with gas of rotational temperature T rot ∼ 15 K, non-thermal velocity dispersion σ NT ∼ 1 km s –1 , and exhibit signs of star formation, while filaments appear to be more quiescent (T rot ∼ 11 K and σ NT ∼ 0.6 km s –1 ). Filaments are parallel in projection and distributed mainly along two directions, at P.A. ∼ 10° and 60°, and appear to be coherent in velocity. The averaged projected separation between adjacent filaments is between 0.5 pc and 1 pc, and the mean width of filaments is 0.12 pc. Cores within filaments are separated by ∼0.33 ± 0.09 pc, which is consistent with the predicted fragmentation of an isothermal gas cylinder due to the s ausage - type instability. The network of parallel filaments observed in G14.225–0.506 is consistent with the gravitational instability of a thin gas layer threaded by magnetic fields. Overall, our data suggest that magnetic fields might play an important role in the alignment of filaments, and polarization measurements in the entire cloud would lend further support to this scenario.

  19. Ancestral sequence alignment under optimal conditions

    Directory of Open Access Journals (Sweden)

    Brown Daniel G

    2005-11-01

    Full Text Available Abstract Background Multiple genome alignment is an important problem in bioinformatics. An important subproblem used by many multiple alignment approaches is that of aligning two multiple alignments. Many popular alignment algorithms for DNA use the sum-of-pairs heuristic, where the score of a multiple alignment is the sum of its induced pairwise alignment scores. However, the biological meaning of the sum-of-pairs of pairs heuristic is not obvious. Additionally, many algorithms based on the sum-of-pairs heuristic are complicated and slow, compared to pairwise alignment algorithms. An alternative approach to aligning alignments is to first infer ancestral sequences for each alignment, and then align the two ancestral sequences. In addition to being fast, this method has a clear biological basis that takes into account the evolution implied by an underlying phylogenetic tree. In this study we explore the accuracy of aligning alignments by ancestral sequence alignment. We examine the use of both maximum likelihood and parsimony to infer ancestral sequences. Additionally, we investigate the effect on accuracy of allowing ambiguity in our ancestral sequences. Results We use synthetic sequence data that we generate by simulating evolution on a phylogenetic tree. We use two different types of phylogenetic trees: trees with a period of rapid growth followed by a period of slow growth, and trees with a period of slow growth followed by a period of rapid growth. We examine the alignment accuracy of four ancestral sequence reconstruction and alignment methods: parsimony, maximum likelihood, ambiguous parsimony, and ambiguous maximum likelihood. Additionally, we compare against the alignment accuracy of two sum-of-pairs algorithms: ClustalW and the heuristic of Ma, Zhang, and Wang. Conclusion We find that allowing ambiguity in ancestral sequences does not lead to better multiple alignments. Regardless of whether we use parsimony or maximum likelihood, the

  20. Reliability of the Radiographic Sagittal and Frontal Tibiotalar Alignment after Ankle Arthrodesis.

    Science.gov (United States)

    Willegger, Madeleine; Holinka, Johannes; Nemecek, Elena; Bock, Peter; Wanivenhaus, Axel Hugo; Windhager, Reinhard; Schuh, Reinhard

    2016-01-01

    Accurate measurement of the tibiotalar alignment is important in radiographic outcome assessment of ankle arthrodesis (AA). In studies, various radiological methods have been used to measure the tibiotalar alignment leading to facultative misinterpretation of results. However, to our knowledge, no previous study has investigated the reliability of tibiotalar alignment measurement in AA. We aimed to investigate the reliability of four different methods of measurement of the frontal and sagittal tibiotalar alignment after AA, and to further clarify the most reliable method for determining the longitudinal axis of the tibia. Thirty-eight weight bearing anterior to posterior and lateral ankle radiographs of thirty-seven patients who had undergone AA with a two screw fixation technique were selected. Three observers measured the frontal tibiotalar angle (FTTA) and the sagittal tibiotalar angle (STTA) using four different methods. The methods differed by the definition of the longitudinal tibial axis. Method A was defined by a line drawn along the lateral tibial border in anterior to posterior radiographs and along the posterior tibial border in lateral radiographs. Method B was defined by a line connecting two points in the middle of the proximal and the distal tibial shaft. Method C was drawn "freestyle"along the longitudinal axis of the tibia, and method D was defined by a line connecting the center of the tibial articular surface and a point in the middle of the proximal tibial shaft. Intra- and interobserver correlation coefficients (ICC) and repeated measurement ANOVA were calculated to assess measurement reliability and accuracy. All four methods showed excellent inter- and intraobserver reliability for the FTTA and the STTA. When the longitudinal tibial axis is defined by connecting two points in the middle of the proximal and the distal tibial shaft, the highest interobserver reliability for the FTTA (ICC: 0.980; CI 95%: 0.966-0.989) and for the STTA (ICC: 0

  1. Reliability of the Radiographic Sagittal and Frontal Tibiotalar Alignment after Ankle Arthrodesis.

    Directory of Open Access Journals (Sweden)

    Madeleine Willegger

    Full Text Available Accurate measurement of the tibiotalar alignment is important in radiographic outcome assessment of ankle arthrodesis (AA. In studies, various radiological methods have been used to measure the tibiotalar alignment leading to facultative misinterpretation of results. However, to our knowledge, no previous study has investigated the reliability of tibiotalar alignment measurement in AA. We aimed to investigate the reliability of four different methods of measurement of the frontal and sagittal tibiotalar alignment after AA, and to further clarify the most reliable method for determining the longitudinal axis of the tibia.Thirty-eight weight bearing anterior to posterior and lateral ankle radiographs of thirty-seven patients who had undergone AA with a two screw fixation technique were selected. Three observers measured the frontal tibiotalar angle (FTTA and the sagittal tibiotalar angle (STTA using four different methods. The methods differed by the definition of the longitudinal tibial axis. Method A was defined by a line drawn along the lateral tibial border in anterior to posterior radiographs and along the posterior tibial border in lateral radiographs. Method B was defined by a line connecting two points in the middle of the proximal and the distal tibial shaft. Method C was drawn "freestyle"along the longitudinal axis of the tibia, and method D was defined by a line connecting the center of the tibial articular surface and a point in the middle of the proximal tibial shaft. Intra- and interobserver correlation coefficients (ICC and repeated measurement ANOVA were calculated to assess measurement reliability and accuracy.All four methods showed excellent inter- and intraobserver reliability for the FTTA and the STTA. When the longitudinal tibial axis is defined by connecting two points in the middle of the proximal and the distal tibial shaft, the highest interobserver reliability for the FTTA (ICC: 0.980; CI 95%: 0.966-0.989 and for the

  2. CLIC main beam quadrupole active pre-alignment based on cam movers

    CERN Document Server

    Kemppinen, J; Leuxe, R; Mainaud Durand, H; Sandomierski, J; Sosin, M

    2012-01-01

    Compact Linear Collider (CLIC) is a study for a future 48 km long linear electron-positron collider in the multi TeV range. Its target luminosity can only be reached if the main beam quadrupoles (MB quads) are actively pre-aligned within 17 µm in sliding windows of 200 m with respect to a straight reference line. In addition to the positioning requirement, the pre-alignment system has to provide a rigid support for the nano-stabilization system to ensure that the first eigenfrequency is above 100 Hz. Re-adjustment based on cam movers was chosen for detailed studies to meet the stringent pre-alignment requirements. There are four different types of MB quads in CLIC. Their lengths and masses vary so that at least two types of cam movers have to be developed. The validation of the cams with less stringent space restrictions has proceeded to a test setup in 5 degrees of freedom (DOF). Prototypes of the more demanding, smaller cams have been manufactured and they are under tests in 1 DOF. This paper describes the...

  3. Fabrication of Si-nozzles for parallel mechano-electrospinning direct writing

    International Nuclear Information System (INIS)

    Pan, Yanqiao; Huang, YongAn; Bu, Ningbin; Yin, Zhouping

    2013-01-01

    Nozzles with micro-scale orifices drive high-resolution printing techniques for generating micro- to nano-scale droplets/lines. This paper presents the fabrication and application of Si-nozzles in mechano-electrospinning (MES). The fabrication process mainly consists of photolithography, Au deposition, inductively coupled plasma, and polydimethylsiloxane encapsulation. The 6 wt% polyethylene oxide solution is adopted to study the electrospinning behaviour and the relations between fibre diameter and process parameters in MES. A fibre grid with 250 µm spacing is able to be direct written, and the diameters are less than 3 µm. To improve the printing efficiency, positioning accuracy and flexibility, a rotatable multi-nozzle is adopted. The distance between parallel lines reduces sharply from 4.927 to 0.308 mm with the rotating angle increasing from 0° to 87°, and the fibre grids with tunable distance are achieved. This method paves the way for fabrication of addressable Si-nozzle array in parallel MES direct writing. (paper)

  4. Clear aligners in orthodontic treatment.

    Science.gov (United States)

    Weir, T

    2017-03-01

    Since the introduction of the Tooth Positioner (TP Orthodontics) in 1944, removable appliances analogous to clear aligners have been employed for mild to moderate orthodontic tooth movements. Clear aligner therapy has been a part of orthodontic practice for decades, but has, particularly since the introduction of Invisalign appliances (Align Technology) in 1998, become an increasingly common addition to the orthodontic armamentarium. An internet search reveals at least 27 different clear aligner products currently on offer for orthodontic treatment. The present paper will highlight the increasing popularity of clear aligner appliances, as well as the clinical scope and the limitations of aligner therapy in general. Further, the paper will outline the differences between the various types of clear aligner products currently available. © 2017 Australian Dental Association.

  5. Supertracker: A Programmable Parallel Pipeline Arithmetic Processor For Auto-Cueing Target Processing

    Science.gov (United States)

    Mack, Harold; Reddi, S. S.

    1980-04-01

    Supertracker represents a programmable parallel pipeline computer architecture that has been designed to meet the real time image processing requirements of auto-cueing target data processing. The prototype bread-board currently under development will be designed to perform input video preprocessing and processing for 525-line and 875-line TV formats FLIR video, automatic display gain and contrast control, and automatic target cueing, classification, and tracking. The video preprocessor is capable of performing operations full frames of video data in real time, e.g., frame integration, storage, 3 x 3 convolution, and neighborhood processing. The processor architecture is being implemented using bit-slice microprogrammable arithmetic processors, operating in parallel. Each processor is capable of up to 20 million operations per second. Multiple frame memories are used for additional flexibility.

  6. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    Gervasio Gomez

    2012-01-01

      The new alignment for the DT chambers has been successfully used in physics analysis starting with the 52X Global Tag. The remaining main areas of development over the next few months will be preparing a new track-based CSC alignment and producing realistic APEs (alignment position errors) and MC misalignment scenarios to match the latest muon alignment constants. Work on these items has been delayed from the intended timeline, mostly due to a large involvement of the muon alignment man-power in physics analyses over the first half of this year. As CMS keeps probing higher and higher energies, special attention must be paid to the reconstruction of very-high-energy muons. Recent muon POG reports from mid-June show a φ-dependence in curvature bias in Monte Carlo samples. This bias is observed already at the tracker level, where it is constant with muon pT, while it grows with pT as muon chamber information is added to the tracks. Similar studies show a much smaller effect in data, at le...

  7. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez

    2010-01-01

    For the last three months, the Muon Alignment group has focussed on providing a new, improved set of alignment constants for the end-of-year data reprocessing. These constants were delivered on time and approved by the CMS physics validation team on November 17. The new alignment incorporates several improvements over the previous one from March for nearly all sub-systems. Motivated by the loss of information from a hardware failure in May (an entire MAB was lost), the optical barrel alignment has moved from a modular, super-plane reconstruction, to a full, single loop calculation of the entire geometry for all DTs in stations 1, 2 and 3. This makes better use of the system redundancy, mitigating the effect of the information loss. Station 4 is factorised and added afterwards to make the system smaller (and therefore faster to run), and also because the MAB calibration at the MB4 zone is less precise. This new alignment procedure was tested at 0 T against photogrammetry resulting in precisions of the order...

  8. Linux command line and shell scripting bible

    CERN Document Server

    Blum, Richard

    2014-01-01

    Talk directly to your system for a faster workflow with automation capability Linux Command Line and Shell Scripting Bible is your essential Linux guide. With detailed instruction and abundant examples, this book teaches you how to bypass the graphical interface and communicate directly with your computer, saving time and expanding capability. This third edition incorporates thirty pages of new functional examples that are fully updated to align with the latest Linux features. Beginning with command line fundamentals, the book moves into shell scripting and shows you the practical application

  9. How accurate is anatomic limb alignment in predicting mechanical limb alignment after total knee arthroplasty?

    Science.gov (United States)

    Lee, Seung Ah; Choi, Sang-Hee; Chang, Moon Jong

    2015-10-27

    Anatomic limb alignment often differs from mechanical limb alignment after total knee arthroplasty (TKA). We sought to assess the accuracy, specificity, and sensitivity for each of three commonly used ranges for anatomic limb alignment (3-9°, 5-10° and 2-10°) in predicting an acceptable range (neutral ± 3°) for mechanical limb alignment after TKA. We also assessed whether the accuracy of anatomic limb alignment was affected by anatomic variation. This retrospective study included 314 primary TKAs. The alignment of the limb was measured with both anatomic and mechanical methods of measurement. We also measured anatomic variation, including the femoral bowing angle, tibial bowing angle, and neck-shaft angle of the femur. All angles were measured on the same full-length standing anteroposterior radiographs. The accuracy, specificity, and sensitivity for each range of anatomic limb alignment were calculated and compared using mechanical limb alignment as the reference standard. The associations between the accuracy of anatomic limb alignment and anatomic variation were also determined. The range of 2-10° for anatomic limb alignment showed the highest accuracy, but it was only 73 % (3-9°, 65 %; 5-10°, 67 %). The specificity of the 2-10° range was 81 %, which was higher than that of the other ranges (3-9°, 69 %; 5-10°, 67 %). However, the sensitivity of the 2-10° range to predict varus malalignment was only 16 % (3-9°, 35 %; 5-10°, 68 %). In addition, the sensitivity of the 2-10° range to predict valgus malalignment was only 43 % (3-9°, 71 %; 5-10°, 43 %). The accuracy of anatomical limb alignment was lower for knees with greater femoral (odds ratio = 1.2) and tibial (odds ratio = 1.2) bowing. Anatomic limb alignment did not accurately predict mechanical limb alignment after TKA, and its accuracy was affected by anatomic variation. Thus, alignment after TKA should be assessed by measuring mechanical alignment rather than anatomic

  10. Strategic Alignment and New Product Development

    DEFF Research Database (Denmark)

    Acur, Nuran; Kandemir, Destan; Boer, Harry

    2012-01-01

    Strategic alignment is widely accepted as a prerequisite for a firm’s success, but insight into the role of alignment in, and its impact on, the new product evelopment (NPD) process and its performance is less well developed. Most publications on this topic either focus on one form of alignment...... of NPD performance indicators. Strategic planning and innovativeness appear to affect technological, market, and NPD-marketing alignment positively. Environmental munificence is negatively associated with NPD-marketing alignment, but has no effect on the two other forms of alignment. Technological change...... has a positive effect on technological alignment, a negative effect on NPD-marketing alignment, but no effect on market alignment. These findings suggest that internal capabilities are more likely to be associated with the development of strategic alignment than environmental factors are. Furthermore...

  11. Alignment and vibration issues in TeV linear collider design

    International Nuclear Information System (INIS)

    Fischer, G.E.

    1989-07-01

    The next generation of linear colliders will require alignment accuracies and stabilities of component placement at least one, perhaps two, orders of magnitude better than can be achieved by the conventional methods and procedures in practice today. The magnitudes of these component-placement tolerances for current designs of various linear collider subsystems are tabulated. In the micron range, long-term ground motion is sufficiently rapid that on-line reference and mechanical correction systems are called for. Some recent experiences with the upgraded SLAC laser alignment systems and examples of some conceivable solutions for the future are described. The so called ''girder'' problem is discussed in the light of ambient and vibratory disturbances. The importance of the quality of the underlying geology is stressed. The necessity and limitations of public-beam-derived placement information are mentioned. 40 refs., 4 figs., 1 tab

  12. Polarisation in the auroral red line during coordinated EISCAT Svalbard Radar/optical experiments

    Directory of Open Access Journals (Sweden)

    M. Barthélémy

    2011-06-01

    Full Text Available The polarisation of the atomic oxygen red line in the Earth's thermosphere is observed in different configurations with respect to the magnetic field line at high latitude during several coordinated Incoherent Scatter radar/optical experiment campaigns. When pointing northward with a line-of-sight nearly perpendicular to the magnetic field, we show that, as expected, the polarisation is due to precipitated electrons with characteristic energies of a few hundreds of electron Volts. When pointing toward the zenith or southward with a line-of-sight more parallel to the magnetic field, we show that the polarisation practically disappears. This confirms experimentally the predictions deduced from the recent discovery of the red line polarisation. We show that the polarisation direction is parallel to the magnetic field line during geomagnetic activity intensification and that these results are in agreement with theoretical work.

  13. ABS: Sequence alignment by scanning

    KAUST Repository

    Bonny, Mohamed Talal; Salama, Khaled N.

    2011-01-01

    Sequence alignment is an essential tool in almost any computational biology research. It processes large database sequences and considered to be high consumers of computation time. Heuristic algorithms are used to get approximate but fast results. We introduce fast alignment algorithm, called Alignment By Scanning (ABS), to provide an approximate alignment of two DNA sequences. We compare our algorithm with the well-known alignment algorithms, the FASTA (which is heuristic) and the 'Needleman-Wunsch' (which is optimal). The proposed algorithm achieves up to 76% enhancement in alignment score when it is compared with the FASTA Algorithm. The evaluations are conducted using different lengths of DNA sequences. © 2011 IEEE.

  14. ABS: Sequence alignment by scanning

    KAUST Repository

    Bonny, Mohamed Talal

    2011-08-01

    Sequence alignment is an essential tool in almost any computational biology research. It processes large database sequences and considered to be high consumers of computation time. Heuristic algorithms are used to get approximate but fast results. We introduce fast alignment algorithm, called Alignment By Scanning (ABS), to provide an approximate alignment of two DNA sequences. We compare our algorithm with the well-known alignment algorithms, the FASTA (which is heuristic) and the \\'Needleman-Wunsch\\' (which is optimal). The proposed algorithm achieves up to 76% enhancement in alignment score when it is compared with the FASTA Algorithm. The evaluations are conducted using different lengths of DNA sequences. © 2011 IEEE.

  15. Fast global sequence alignment technique

    KAUST Repository

    Bonny, Mohamed Talal

    2011-11-01

    Bioinformatics database is growing exponentially in size. Processing these large amount of data may take hours of time even if super computers are used. One of the most important processing tool in Bioinformatics is sequence alignment. We introduce fast alignment algorithm, called \\'Alignment By Scanning\\' (ABS), to provide an approximate alignment of two DNA sequences. We compare our algorithm with the wellknown sequence alignment algorithms, the \\'GAP\\' (which is heuristic) and the \\'Needleman-Wunsch\\' (which is optimal). The proposed algorithm achieves up to 51% enhancement in alignment score when it is compared with the GAP Algorithm. The evaluations are conducted using different lengths of DNA sequences. © 2011 IEEE.

  16. Analysis of the Numerical Diffusion in Anisotropic Mediums: Benchmarks for Magnetic Field Aligned Meshes in Space Propulsion Simulations

    Directory of Open Access Journals (Sweden)

    Daniel Pérez-Grande

    2016-11-01

    Full Text Available This manuscript explores numerical errors in highly anisotropic diffusion problems. First, the paper addresses the use of regular structured meshes in numerical solutions versus meshes aligned with the preferential directions of the problem. Numerical diffusion in structured meshes is quantified by solving the classical anisotropic diffusion problem; the analysis is exemplified with the application to a numerical model of conducting fluids under magnetic confinement, where rates of transport in directions parallel and perpendicular to a magnetic field are quite different. Numerical diffusion errors in this problem promote the use of magnetic field aligned meshes (MFAM. The generation of this type of meshes presents some challenges; several meshing strategies are implemented and analyzed in order to provide insight into achieving acceptable mesh regularity. Second, Gradient Reconstruction methods for magnetically aligned meshes are addressed and numerical errors are compared for the structured and magnetically aligned meshes. It is concluded that using the latter provides a more correct and straightforward approach to solving problems where anisotropicity is present, especially, if the anisotropicity level is high or difficult to quantify. The conclusions of the study may be extrapolated to the study of anisotropic flows different from conducting fluids.

  17. Atmospheric lidar co-alignment sensor: flight model electro-optical characterization campaign

    Science.gov (United States)

    Valverde Guijarro, Ángel Luis; Belenguer Dávila, Tomás.; Laguna Hernandez, Hugo; Ramos Zapata, Gonzalo

    2017-10-01

    Due to the difficulty in studying the upper layer of the troposphere by using ground-based instrumentation, the conception of a space-orbit atmospheric LIDAR (ATLID) becomes necessary. ATLID born in the ESA's EarthCare Programme framework as one of its payloads, being the first instrument of this kind that will be in the Space. ATLID will provide vertical profiles of aerosols and thin clouds, separating the relative contribution of aerosol and molecular scattering to know aerosol optical depth. It operates at a wavelength of 355 nm and has a high spectral resolution receiver and depolarization channel with a vertical resolution up to 100m from ground to an altitude of 20 km and, and up to 500m from 20km to 40km. ATLID measurements will be done from a sun-synchronous orbit at 393 km altitude, and an alignment (co-alignment) sensor (CAS) is revealed as crucial due to the way in which LIDAR analyses the troposphere. As in previous models, INTA has been in charge of part of the ATLID instrument co-alignment sensor (ATLID-CAS) electro-optical characterization campaign. CAS includes a set of optical elements to take part of the useful signal, to direct it onto the memory CCD matrix (MCCD) used for the co-alignment determination, and to focus the selected signal on the MCCD. Several tests have been carried out for a proper electro-optical characterization: CAS line of sight (LoS) determination and stability, point spread function (PSF), absolute response (AbsRes), pixel response non uniformity (PRNU), response linearity (ResLin) and spectral response. In the following lines, a resume of the flight model electrooptical characterization campaign is reported on. In fact, results concerning the protoflight model (CAS PFM) will be summarized. PFM requires flight-level characterization, so most of the previously mentioned tests must be carried out under simulated working conditions, i.e., the vacuum level (around 10-5 mbar) and temperature range (between 50°C and -30°C) that

  18. Pareto optimal pairwise sequence alignment.

    Science.gov (United States)

    DeRonne, Kevin W; Karypis, George

    2013-01-01

    Sequence alignment using evolutionary profiles is a commonly employed tool when investigating a protein. Many profile-profile scoring functions have been developed for use in such alignments, but there has not yet been a comprehensive study of Pareto optimal pairwise alignments for combining multiple such functions. We show that the problem of generating Pareto optimal pairwise alignments has an optimal substructure property, and develop an efficient algorithm for generating Pareto optimal frontiers of pairwise alignments. All possible sets of two, three, and four profile scoring functions are used from a pool of 11 functions and applied to 588 pairs of proteins in the ce_ref data set. The performance of the best objective combinations on ce_ref is also evaluated on an independent set of 913 protein pairs extracted from the BAliBASE RV11 data set. Our dynamic-programming-based heuristic approach produces approximated Pareto optimal frontiers of pairwise alignments that contain comparable alignments to those on the exact frontier, but on average in less than 1/58th the time in the case of four objectives. Our results show that the Pareto frontiers contain alignments whose quality is better than the alignments obtained by single objectives. However, the task of identifying a single high-quality alignment among those in the Pareto frontier remains challenging.

  19. Coupling SIMD and SIMT architectures to boost performance of a phylogeny-aware alignment kernel

    Directory of Open Access Journals (Sweden)

    Alachiotis Nikolaos

    2012-08-01

    Full Text Available Abstract Background Aligning short DNA reads to a reference sequence alignment is a prerequisite for detecting their biological origin and analyzing them in a phylogenetic context. With the PaPaRa tool we introduced a dedicated dynamic programming algorithm for simultaneously aligning short reads to reference alignments and corresponding evolutionary reference trees. The algorithm aligns short reads to phylogenetic profiles that correspond to the branches of such a reference tree. The algorithm needs to perform an immense number of pairwise alignments. Therefore, we explore vector intrinsics and GPUs to accelerate the PaPaRa alignment kernel. Results We optimized and parallelized PaPaRa on CPUs and GPUs. Via SSE 4.1 SIMD (Single Instruction, Multiple Data intrinsics for x86 SIMD architectures and multi-threading, we obtained a 9-fold acceleration on a single core as well as linear speedups with respect to the number of cores. The peak CPU performance amounts to 18.1 GCUPS (Giga Cell Updates per Second using all four physical cores on an Intel i7 2600 CPU running at 3.4 GHz. The average CPU performance (averaged over all test runs is 12.33 GCUPS. We also used OpenCL to execute PaPaRa on a GPU SIMT (Single Instruction, Multiple Threads architecture. A NVIDIA GeForce 560 GPU delivered peak and average performance of 22.1 and 18.4 GCUPS respectively. Finally, we combined the SIMD and SIMT implementations into a hybrid CPU-GPU system that achieved an accumulated peak performance of 33.8 GCUPS. Conclusions This accelerated version of PaPaRa (available at http://www.exelixis-lab.org/software.html provides a significant performance improvement that allows for analyzing larger datasets in less time. We observe that state-of-the-art SIMD and SIMT architectures deliver comparable performance for this dynamic programming kernel when the “competing programmer approach” is deployed. Finally, we show that overall performance can be substantially increased

  20. Alignment for CSR

    International Nuclear Information System (INIS)

    Wang Shoujin; Man Kaidi; Guo Yizhen; Cai Guozhu; Guo Yuhui

    2002-01-01

    Cooled Storage Ring of Heavy Ion Research Facility in Lanzhou (HIRFL-CSR) belongs to China great scientific project in China. The alignment for it is very difficult because of very large area and very high accuracy. For the special case in HIRFL-CSR, some new methods and new instruments are used, including the construction of survey control network, the usage of laser tracker, and CSR alignment database system with applications developed to store and analyze data. The author describes the whole procedure of CSR alignment

  1. Sensitivity enhancement for membrane proteins reconstituted in parallel and perpendicular oriented bicelles obtained by using repetitive cross-polarization and membrane-incorporated free radicals

    Energy Technology Data Exchange (ETDEWEB)

    Koroloff, Sophie N. [North Carolina State University, Department of Chemistry (United States); Tesch, Deanna M. [Shaw University (United States); Awosanya, Emmanuel O.; Nevzorov, Alexander A., E-mail: alex-nevzorov@ncsu.edu [North Carolina State University, Department of Chemistry (United States)

    2017-02-15

    Multidimensional separated local-field and spin-exchange experiments employed by oriented-sample solid-state NMR are essential for structure determination and spectroscopic assignment of membrane proteins reconstituted in macroscopically aligned lipid bilayers. However, these experiments typically require a large number of scans in order to establish interspin correlations. Here we have shown that a combination of optimized repetitive cross polarization (REP-CP) and membrane-embedded free radicals allows one to enhance the signal-to-noise ratio by factors 2.4-3.0 in the case of Pf1 coat protein reconstituted in magnetically aligned bicelles with their normals being either parallel or perpendicular to the main magnetic field. Notably, spectral resolution is not affected at the 2:1 radical-to-protein ratio. Spectroscopic assignment of Pf1 coat protein in the parallel bicelles has been established as an illustration of the method. The proposed methodology will advance applications of oriented-sample NMR technique when applied to samples containing smaller quantities of proteins and three-dimensional experiments.

  2. A generalized global alignment algorithm.

    Science.gov (United States)

    Huang, Xiaoqiu; Chao, Kun-Mao

    2003-01-22

    Homologous sequences are sometimes similar over some regions but different over other regions. Homologous sequences have a much lower global similarity if the different regions are much longer than the similar regions. We present a generalized global alignment algorithm for comparing sequences with intermittent similarities, an ordered list of similar regions separated by different regions. A generalized global alignment model is defined to handle sequences with intermittent similarities. A dynamic programming algorithm is designed to compute an optimal general alignment in time proportional to the product of sequence lengths and in space proportional to the sum of sequence lengths. The algorithm is implemented as a computer program named GAP3 (Global Alignment Program Version 3). The generalized global alignment model is validated by experimental results produced with GAP3 on both DNA and protein sequences. The GAP3 program extends the ability of standard global alignment programs to recognize homologous sequences of lower similarity. The GAP3 program is freely available for academic use at http://bioinformatics.iastate.edu/aat/align/align.html.

  3. Assignment of stock keeping units to parallel undirectional picking

    Directory of Open Access Journals (Sweden)

    Matthews, Jason

    2015-05-01

    Full Text Available An order picking system consisting of a number of parallel unidirectional picking lines is investigated. Stock keeping units (SKUs that are grouped by product type into distributions (DBNs are assigned daily to available picking lines. A mathematical programming formulation and its relaxations is presented. A greedy insertion and a greedy phased insertion are further introduced to obtain feasible results within usable computation times for all test cases. The walking distance of the pickers was shown to decrease by about 22 per cent compared with the current assignment approach. However, product handling and operational risk increases.

  4. Novel pulse amplifying circuits based on transmission lines of different characteristic impedance

    International Nuclear Information System (INIS)

    Belloni, F.; Doria, D.; Lorusso, A.; Nassisi, V.

    2006-01-01

    Two novel circuits used to amplify electric pulses by the coupling of transmission lines of different characteristic impedance are described. The circuits are intended for doubling voltage pulses and for doubling current pulses. The former is composed by a R 0 transmission line closed on a set of two 2R 0 storage lines connected in parallel, while the latter is composed by a R 0 transmission line closed on a set of two R 0 /2 storage lines connected in series. The length of every storage line is half of input-pulse length. In both circuits, one storage line is characterized by an open extremity and the other line by a closed extremity. Connecting opportunely the storage lines to suitable load resistors, 4R 0 and R 0 /4, for the circuit having parallel and series connected lines, respectively, a twice of the output pulse intensity is obtained. Such devices are very suitable to generate high intensity voltage and/or current peaks which are very interesting in the field of the accelerators. Both circuit behaviours have been theoretically studied and verified by computer simulations

  5. Progressive multiple sequence alignments from triplets

    Directory of Open Access Journals (Sweden)

    Stadler Peter F

    2007-07-01

    Full Text Available Abstract Background The quality of progressive sequence alignments strongly depends on the accuracy of the individual pairwise alignment steps since gaps that are introduced at one step cannot be removed at later aggregation steps. Adjacent insertions and deletions necessarily appear in arbitrary order in pairwise alignments and hence form an unavoidable source of errors. Research Here we present a modified variant of progressive sequence alignments that addresses both issues. Instead of pairwise alignments we use exact dynamic programming to align sequence or profile triples. This avoids a large fractions of the ambiguities arising in pairwise alignments. In the subsequent aggregation steps we follow the logic of the Neighbor-Net algorithm, which constructs a phylogenetic network by step-wisely replacing triples by pairs instead of combining pairs to singletons. To this end the three-way alignments are subdivided into two partial alignments, at which stage all-gap columns are naturally removed. This alleviates the "once a gap, always a gap" problem of progressive alignment procedures. Conclusion The three-way Neighbor-Net based alignment program aln3nn is shown to compare favorably on both protein sequences and nucleic acids sequences to other progressive alignment tools. In the latter case one easily can include scoring terms that consider secondary structure features. Overall, the quality of resulting alignments in general exceeds that of clustalw or other multiple alignments tools even though our software does not included heuristics for context dependent (mismatch scores.

  6. The importance of triaxial shapes in spin aligned configurations in the A = 170-180 mass region

    International Nuclear Information System (INIS)

    Bengtsson, R.

    1990-01-01

    Deformations determined from total routhian surfaces (TRS) for the yrast states of even-even isotopes of W, Os, and Pt are presented. The calculated deformations imply a number of specific features for the yrast line, resulting from deformation changes and the alignment of specific pairs of quasiparticles. The triaxial shapes predicted from the TRS are important for determining the character of the aligning particles as well as for making a correct interpretation of the strength of the interaction between crossing bands and the bandcrossing frequencies. 19 refs., 9 figs

  7. Belt Aligning Revisited

    Directory of Open Access Journals (Sweden)

    Yurchenko Vadim

    2017-01-01

    parts of the conveyor, the sides of the belt wear intensively. This results in reducing the life of the belt. The reasons for this phenomenon are well investigated, but the difficulty lies in the fact that they all act simultaneously. The belt misalignment prevention can be carried out in two ways: by minimizing the effect of causes and by aligning the belt. The construction of aligning devices and errors encountered in practice are considered in this paper. Self-aligning roller supports rotational in plan view are recommended as a means of combating the belt misalignment.

  8. An ice-templated, linearly aligned chitosan-alginate scaffold for neural tissue engineering.

    Science.gov (United States)

    Francis, Nicola L; Hunger, Philipp M; Donius, Amalie E; Riblett, Benjamin W; Zavaliangos, Antonios; Wegst, Ulrike G K; Wheatley, Margaret A

    2013-12-01

    Several strategies have been investigated to enhance axonal regeneration after spinal cord injury, however, the resulting growth can be random and disorganized. Bioengineered scaffolds provide a physical substrate for guidance of regenerating axons towards their targets, and can be produced by freeze casting. This technique involves the controlled directional solidification of an aqueous solution or suspension, resulting in a linearly aligned porous structure caused by ice templating. In this study, freeze casting was used to fabricate porous chitosan-alginate (C/A) scaffolds with longitudinally oriented channels. Chick dorsal root ganglia explants adhered to and extended neurites through the scaffold in parallel alignment with the channel direction. Surface adsorption of a polycation and laminin promoted significantly longer neurite growth than the uncoated scaffold (poly-L-ornithine + Laminin = 793.2 ± 187.2 μm; poly-L-lysine + Laminin = 768.7 ± 241.2 μm; uncoated scaffold = 22.52 ± 50.14 μm) (P < 0.001). The elastic modulus of the hydrated scaffold was determined to be 5.08 ± 0.61 kPa, comparable to reported spinal cord values. The present data suggested that this C/A scaffold is a promising candidate for use as a nerve guidance scaffold, because of its ability to support neuronal attachment and the linearly aligned growth of DRG neurites. Copyright © 2013 Wiley Periodicals, Inc., a Wiley Company.

  9. Convection and field-aligned currents, related to polar cap arcs, during strongly northward IMF (11 January 1983)

    International Nuclear Information System (INIS)

    Israelevich, P.L.; Podgorny, I.M.; Kuzmin, A.K.; Nikolaeva, N.S.; Dubinin, E.M.

    1988-01-01

    Electric and magnetic fields and auroral emissions have been measured by the Intercosmos-Bulgaria-1300 satellite on 10-11 January 1983. The measured distributions of the plasma drift velocity show that viscous convection is diminished in the evening sector under IMF B y y > 0. A number of sun-aligned polar cap arcs were observed at the beginning of the period of strongly northward IMF and after a few hours a θ-aurora appeared. The intensity of ionized oxygen emission increased significantly reaching up to several kilo-Rayleighs in the polar cap arc. A complicated pattern of convection and field-aligned currents existed in the nightside polar cap which differed from the four-cell model of convection and NBZ field-aligned current system. This pattern was observed during 12 h and could be interpreted as six large scale field-aligned current sheets and three convective vortices inside the polar cap. Sun-aligned polar cap arcs may be located in regions both of sunward and anti-sunward convection. Structures of smaller spatial scale-correspond to the boundaries of hot plasma regions related to polar cap arcs. Obviously these structures are due to S-shaped distributions of electric potential. Parallel electric fields in these S-structures provide electron acceleration up to 1 keV at the boundaries of polar cap arcs. The pairs of field-aligned currents correspond to those S-structures: a downward current at the external side of the boundary and an upward current at the internal side of it. (author)

  10. Antares beam-alignment-system performance

    International Nuclear Information System (INIS)

    Appert, Q.D.; Bender, S.C.

    1983-01-01

    The beam alignment system for the 24-beam-sector Antares CO 2 fusion laser automatically aligns more than 200 optical elements. A visible-wavelength alignment technique is employed which uses a telescope/TV system to view point-light sources appropriately located down the beamline. The centroids of the light spots are determined by a video tracker, which generates error signals used by the computer control system to move appropriate mirrors in a closed-loop system. Final touch-up alignment is accomplished by projecting a CO 2 alignment laser beam through the system and sensing its position at the target location. The techniques and control algorithms employed have resulted in alignment accuracies exceeding design requirements. By employing video processing to determine the centroids of diffraction images and by averaging over multiple TV frames, we achieve alignment accuracies better than 0.1 times system diffraction limits in the presence of air turbulence

  11. The aligned K-center problem

    KAUST Repository

    Braß, Peter

    2011-04-01

    In this paper we study several instances of the aligned k-center problem where the goal is, given a set of points S in the plane and a parameter k ≥ 1, to find k disks with centers on a line ℓ such that their union covers S and the maximum radius of the disks is minimized. This problem is a constrained version of the well-known k-center problem in which the centers are constrained to lie in a particular region such as a segment, a line, or a polygon. We first consider the simplest version of the problem where the line ℓ is given in advance; we can solve this problem in time O(n log2 n). In the case where only the direction of ℓ is fixed, we give an O(n2 log 2 n)-time algorithm. When ℓ is an arbitrary line, we give a randomized algorithm with expected running time O(n4 log2 n). Then we present (1+ε)-approximation algorithms for these three problems. When we denote T(k, ε) = (k/ε2+(k/ε) log k) log(1/ε), these algorithms run in O(n log k + T(k, ε)) time, O(n log k + T(k, ε)/ε) time, and O(n log k + T(k, ε)/ε2) time, respectively. For k = O(n1/3/log n), we also give randomized algorithms with expected running times O(n + (k/ε2) log(1/ε)), O(n+(k/ε3) log(1/ε)), and O(n + (k/ε4) log(1/ε)), respectively. © 2011 World Scientific Publishing Company.

  12. A UNIFIED MODEL OF GRAIN ALIGNMENT: RADIATIVE ALIGNMENT OF INTERSTELLAR GRAINS WITH MAGNETIC INCLUSIONS

    Energy Technology Data Exchange (ETDEWEB)

    Hoang, Thiem [Canadian Institute for Theoretical Astrophysics, University of Toronto, 60 St. George Street, Toronto, ON M5S 3H8 (Canada); Lazarian, A. [Department of Astronomy, University of Wisconsin-Madison (United States)

    2016-11-10

    The radiative torque (RAT) alignment of interstellar grains with ordinary paramagnetic susceptibilities has been supported by earlier studies. The alignment of such grains depends on the so-called RAT parameter q {sup max}, which is determined by the grain shape. In this paper, we elaborate on our model of RAT alignment for grains with enhanced magnetic susceptibility due to iron inclusions, such that RAT alignment is magnetically enhanced, which we term the MRAT mechanism. Such grains can be aligned with high angular momentum at the so-called high- J attractor points, achieving a high degree of alignment. Using our analytical model of RATs, we derive the critical value of the magnetic relaxation parameter δ {sub m} to produce high- J attractor points as functions of q {sup max} and the anisotropic radiation angle relative to the magnetic field ψ . We find that if about 10% of the total iron abundance present in silicate grains is forming iron clusters, this is sufficient to produce high- J attractor points for all reasonable values of q {sup max}. To calculate the degree of grain alignment, we carry out numerical simulations of MRAT alignment by including stochastic excitations from gas collisions and magnetic fluctuations. We show that large grains can achieve perfect alignment when the high- J attractor point is present, regardless of the values of q {sup max}. Our obtained results pave the way for the physical modeling of polarized thermal dust emission as well as magnetic dipole emission. We also find that millimeter-sized grains in accretion disks may be aligned with the magnetic field if they are incorporated with iron nanoparticles.

  13. Reconstruction of multiple line source attenuation maps

    International Nuclear Information System (INIS)

    Celler, A.; Sitek, A.; Harrop, R.

    1996-01-01

    A simple configuration for a transmission source for the single photon emission computed tomography (SPECT) was proposed, which utilizes a series of collimated line sources parallel to the axis of rotation of a camera. The detector is equipped with a standard parallel hole collimator. We have demonstrated that this type of source configuration can be used to generate sufficient data for the reconstruction of the attenuation map when using 8-10 line sources spaced by 3.5-4.5 cm for a 30 x 40cm detector at 65cm distance from the sources. Transmission data for a nonuniform thorax phantom was simulated, then binned and reconstructed using filtered backprojection (FBP) and iterative methods. The optimum maps are obtained with data binned into 2-3 bins and FBP reconstruction. The activity in the source was investigated for uniform and exponential activity distributions, as well as the effect of gaps and overlaps of the neighboring fan beams. A prototype of the line source has been built and the experimental verification of the technique has started

  14. RAPID TRANSFER ALIGNMENT USING FEDERATED KALMAN FILTER

    Institute of Scientific and Technical Information of China (English)

    GUDong-qing; QINYong-yuan; PENGRong; LIXin

    2005-01-01

    The dimension number of the centralized Kalman filter (CKF) for the rapid transfer alignment (TA) is as high as 21 if the aircraft wing flexure motion is considered in the rapid TA. The 21-dimensional CKF brings the calculation burden on the computer and the difficulty to meet a high filtering updating rate desired by rapid TA. The federated Kalman filter (FKF) for the rapid TA is proposed to solve the dilemma. The structure and the algorithm of the FKF, which can perform parallel computation and has less calculation burden, are designed.The wing flexure motion is modeled, and then the 12-order velocity matching local filter and the 15-order attitud ematching local filter are devised. Simulation results show that the proposed EKE for the rapid TA almost has the same performance as the CKF. Thus the calculation burden of the proposed FKF for the rapid TA is markedly decreased.

  15. Coordinate measurement machines as an alignment tool

    International Nuclear Information System (INIS)

    Wand, B.T.

    1991-03-01

    In February of 1990 the Stanford Linear Accelerator Center (SLAC) purchased a LEITZ PM 12-10-6 CMM (Coordinate measurement machine). The machine is shared by the Quality Control Team and the Alignment Team. One of the alignment tasks in positioning beamline components in a particle accelerator is to define the component's magnetic centerline relative to external fiducials. This procedure, called fiducialization, is critical to the overall positioning tolerance of a magnet. It involves the definition of the magnetic center line with respect to the mechanical centerline and the transfer of the mechanical centerline to the external fiducials. To perform the latter a magnet coordinate system has to be established. This means defining an origin and the three rotation angles of the magnet. The datum definition can be done by either optical tooling techniques or with a CMM. As optical tooling measurements are very time consuming, not automated and are prone to errors, it is desirable to use the CMM fiducialization method instead. The establishment of a magnet coordinate system based on the mechanical center and the transfer to external fiducials will be discussed and presented with 2 examples from the Stanford Linear Collider (SLC). 7 figs

  16. Visual coherence for large-scale line-plot visualizations

    KAUST Repository

    Muigg, Philipp

    2011-06-01

    Displaying a large number of lines within a limited amount of screen space is a task that is common to many different classes of visualization techniques such as time-series visualizations, parallel coordinates, link-node diagrams, and phase-space diagrams. This paper addresses the challenging problems of cluttering and overdraw inherent to such visualizations. We generate a 2x2 tensor field during line rasterization that encodes the distribution of line orientations through each image pixel. Anisotropic diffusion of a noise texture is then used to generate a dense, coherent visualization of line orientation. In order to represent features of different scales, we employ a multi-resolution representation of the tensor field. The resulting technique can easily be applied to a wide variety of line-based visualizations. We demonstrate this for parallel coordinates, a time-series visualization, and a phase-space diagram. Furthermore, we demonstrate how to integrate a focus+context approach by incorporating a second tensor field. Our approach achieves interactive rendering performance for large data sets containing millions of data items, due to its image-based nature and ease of implementation on GPUs. Simulation results from computational fluid dynamics are used to evaluate the performance and usefulness of the proposed method. © 2011 The Author(s).

  17. Visual coherence for large-scale line-plot visualizations

    KAUST Repository

    Muigg, Philipp; Hadwiger, Markus; Doleisch, Helmut; Grö ller, Eduard M.

    2011-01-01

    Displaying a large number of lines within a limited amount of screen space is a task that is common to many different classes of visualization techniques such as time-series visualizations, parallel coordinates, link-node diagrams, and phase-space diagrams. This paper addresses the challenging problems of cluttering and overdraw inherent to such visualizations. We generate a 2x2 tensor field during line rasterization that encodes the distribution of line orientations through each image pixel. Anisotropic diffusion of a noise texture is then used to generate a dense, coherent visualization of line orientation. In order to represent features of different scales, we employ a multi-resolution representation of the tensor field. The resulting technique can easily be applied to a wide variety of line-based visualizations. We demonstrate this for parallel coordinates, a time-series visualization, and a phase-space diagram. Furthermore, we demonstrate how to integrate a focus+context approach by incorporating a second tensor field. Our approach achieves interactive rendering performance for large data sets containing millions of data items, due to its image-based nature and ease of implementation on GPUs. Simulation results from computational fluid dynamics are used to evaluate the performance and usefulness of the proposed method. © 2011 The Author(s).

  18. Galaxy Alignments: Theory, Modelling & Simulations

    Science.gov (United States)

    Kiessling, Alina; Cacciato, Marcello; Joachimi, Benjamin; Kirk, Donnacha; Kitching, Thomas D.; Leonard, Adrienne; Mandelbaum, Rachel; Schäfer, Björn Malte; Sifón, Cristóbal; Brown, Michael L.; Rassat, Anais

    2015-11-01

    The shapes of galaxies are not randomly oriented on the sky. During the galaxy formation and evolution process, environment has a strong influence, as tidal gravitational fields in the large-scale structure tend to align nearby galaxies. Additionally, events such as galaxy mergers affect the relative alignments of both the shapes and angular momenta of galaxies throughout their history. These "intrinsic galaxy alignments" are known to exist, but are still poorly understood. This review will offer a pedagogical introduction to the current theories that describe intrinsic galaxy alignments, including the apparent difference in intrinsic alignment between early- and late-type galaxies and the latest efforts to model them analytically. It will then describe the ongoing efforts to simulate intrinsic alignments using both N-body and hydrodynamic simulations. Due to the relative youth of this field, there is still much to be done to understand intrinsic galaxy alignments and this review summarises the current state of the field, providing a solid basis for future work.

  19. The CMS Muon System Alignment

    CERN Document Server

    Martinez Ruiz-Del-Arbol, P

    2009-01-01

    The alignment of the muon system of CMS is performed using different techniques: photogrammetry measurements, optical alignment and alignment with tracks. For track-based alignment, several methods are employed, ranging from a hit and impact point (HIP) algorithm and a procedure exploiting chamber overlaps to a global fit method based on the Millepede approach. For start-up alignment as long as available integrated luminosity is still significantly limiting the size of the muon sample from collisions, cosmic muon and beam halo signatures play a very strong role. During the last commissioning runs in 2008 the first aligned geometries have been produced and validated with data. The CMS offline computing infrastructure has been used in order to perform improved reconstructions. We present the computational aspects related to the calculation of alignment constants at the CERN Analysis Facility (CAF), the production and population of databases and the validation and performance in the official reconstruction. Also...

  20. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez

    Since September, the muon alignment system shifted from a mode of hardware installation and commissioning to operation and data taking. All three optical subsystems (Barrel, Endcap and Link alignment) have recorded data before, during and after CRAFT, at different magnetic fields and during ramps of the magnet. This first data taking experience has several interesting goals: •    study detector deformations and movements under the influence of the huge magnetic forces; •    study the stability of detector structures and of the alignment system over long periods, •    study geometry reproducibility at equal fields (specially at 0T and 3.8T); •    reconstruct B=0T geometry and compare to nominal/survey geometries; •    reconstruct B=3.8T geometry and provide DT and CSC alignment records for CMSSW. However, the main goal is to recons...

  1. Relation between film character and wafer alignment: critical alignment issues on HV device for VLSI manufacturing

    Science.gov (United States)

    Lo, Yi-Chuan; Lee, Chih-Hsiung; Lin, Hsun-Peng; Peng, Chiou-Shian

    1998-06-01

    Several continuous splits for wafer alignment target topography conditions to improve epitaxy film alignment were applied. The alignment evaluation among former layer pad oxide thickness (250 angstrom - 500 angstrom), drive oxide thickness (6000 angstrom - 10000 angstrom), nitride film thickness (600 angstrom - 1500 angstrom), initial oxide etch (fully wet etch, fully dry etch and dry plus wet etch) will be split to this experiment. Also various epitaxy deposition recipe such as: epitaxy source (SiHCl2 or SiCHCl3) and growth rate (1.3 micrometer/min approximately 2.0 micrometer/min) will be used to optimize the process window for alignment issue. All the reflectance signal and cross section photography of alignment target during NIKON stepper alignment process will be examined. Experimental results show epitaxy recipe plays an important role to wafer alignment. Low growth rate with good performance conformity epitaxy lead to alignment target avoid washout, pattern shift and distortion. All the results (signal monitor and film character) combined with NIKON's stepper standard laser scanning alignment system will be discussed in this paper.

  2. A Wire Position Monitor System for the ISAC-II Cryomodule Components Alignment

    CERN Document Server

    Rawnsley, B; Dutto, G; Fong, K; Laxdal, R E; Ries, T

    2004-01-01

    TRIUMF is developing ISAC-II, a superconducting (SC) linac. It will comprise 9 cryomodules with a total of 48 niobium cavities and 12 SC solenoids. They must remain aligned at liquid He temperatures: cavities to ±400 μm and solenoids to ±200 μm after a vertical contraction of ~4 mm. A wire position monitor (WPM) system based on a TESLA design has been developed, built, and tested with a prototype cryomodule. The system is based on the measurement of signals induced in pickups by a 215 MHz signal carried by a wire through the WPMs. The wire is stretched between the warm tank walls parallel to the beam axis providing a position reference. The sensors, one per cavity and two per solenoid, are attached to the cold elements to monitor their motion during pre-alignment, pumping and cool down. A WPM consists of four 50 Ω striplines spaced 90° apart. A GaAs multiplexer scans the WPMs and a Bergoz card converts the RF signals to DC X and Y voltages. National Ins...

  3. Polarization of submillimetre lines from interstellar medium

    Science.gov (United States)

    Zhang, Heshou; Yan, Huirong

    2018-04-01

    Magnetic fields play important roles in many astrophysical processes. However, there is no universal diagnostic for the magnetic fields in the interstellar medium (ISM) and each magnetic tracer has its limitation. Any new detection method is thus valuable. Theoretical studies have shown that submillimetre fine-structure lines are polarized due to atomic alignment by ultraviolet photon-excitation, which opens up a new avenue to probe interstellar magnetic fields. We will, for the first time, perform synthetic observations on the simulated three-dimensional ISM to demonstrate the measurability of the polarization of submillimetre atomic lines. The maximum polarization for different absorption and emission lines expected from various sources, including star-forming regions are provided. Our results demonstrate that the polarization of submillimetre atomic lines is a powerful magnetic tracer and add great value to the observational studies of the submilimetre astronomy.

  4. Commissioning of the 28 GHz ECRH power transmission line for the TJ-II stellarator

    Energy Technology Data Exchange (ETDEWEB)

    Martínez-Fernández, J., E-mail: jose.martinez@ciemat.es [Laboratorio Nacional de Fusión (LNF), Centro de Investigaciones Tecnológicas, Medioambientales y Tecnológicas (CIEMAT), Av/Complutense 40, 28040 Madrid (Spain); Cappa, Á. [Laboratorio Nacional de Fusión (LNF), Centro de Investigaciones Tecnológicas, Medioambientales y Tecnológicas (CIEMAT), Av/Complutense 40, 28040 Madrid (Spain); Chirkov, A. [Institute of Applied Physics, Russian Academy of Sciences, Nizhny Novgorod (Russian Federation); Ros, A.; Tolkachev, A.; Catalán, G.; Soleto, A.; Redondo, M. [Laboratorio Nacional de Fusión (LNF), Centro de Investigaciones Tecnológicas, Medioambientales y Tecnológicas (CIEMAT), Av/Complutense 40, 28040 Madrid (Spain); Doane, J.L.; Anderson, J.P. [General Atomics, P.O. Box 85608, San Diego, CA 92186-5608 (United States)

    2015-10-15

    Highlights: • The 28 GHz power transmission line of the TJ-II stellarator is described. • Mismatch and alignment problems are covered, presenting infrared measurements. • Beam distortion in the matching optics unit led to unwanted modes in the waveguide. • After a redesign distortion was eliminated and coupling maximized. • Final measurements suggest finer alignment must be performed. - Abstract: The commissioning of the 28 GHz power transmission line of the TJ-II stellarator, designed for the excitation of electron Bernstein waves (EBW) through the O-X-B mode conversion process, is presented in this paper. Based upon a comprehensive set of thermal measurements, its purpose is to go into details about the several problems that arouse during the whole process, namely higher order modes excitation because of the wider beam size and alignment mismatches at the waveguide mouth. All these drawbacks may have prevented the correct O-X mode conversion, thus providing a reasonable explanation for the unsuccessful EBW heating experiments.

  5. Nova laser alignment control system

    International Nuclear Information System (INIS)

    Van Arsdall, P.J.; Holloway, F.W.; McGuigan, D.L.; Shelton, R.T.

    1984-01-01

    Alignment of the Nova laser requires control of hundreds of optical components in the ten beam paths. Extensive application of computer technology makes daily alignment practical. The control system is designed in a manner which provides both centralized and local manual operator controls integrated with automatic closed loop alignment. Menudriven operator consoles using high resolution color graphics displays overlaid with transport touch panels allow laser personnel to interact efficiently with the computer system. Automatic alignment is accomplished by using image analysis techniques to determine beam references points from video images acquired along the laser chain. A major goal of the design is to contribute substantially to rapid experimental turnaround and consistent alignment results. This paper describes the computer-based control structure and the software methods developed for aligning this large laser system

  6. Resolution and systematic limitations in beam based alignment

    Energy Technology Data Exchange (ETDEWEB)

    Tenenbaum, P.G.

    2000-03-15

    Beam based alignment of quadrupoles by variation of quadrupole strength is a widely-used technique in accelerators today. The authors describe the dominant systematic limitation of this technique, which arises from the change in the center position of the quadrupole as the strength is varied, and derive expressions for the resulting error. In addition, the authors derive an expression for the statistical resolution of such techniques in a periodic transport line, given knowledge of the line's transport matrices, the resolution of the beam position monitor system, and the details of the strength variation procedure. These results are applied to the Next Linear Collider main linear accelerator, an 11 kilometer accelerator containing 750 quadrupoles and 5,000 accelerator structures. The authors find that in principle a statistical resolution of 1 micron is easily achievable but the systematic error due to variation of the magnetic centers could be several times larger.

  7. Fantastic Striations and Where to Find Them: The Origin of Magnetically Aligned Striations in Interstellar Clouds

    Energy Technology Data Exchange (ETDEWEB)

    Chen, Che-Yu; Li, Zhi-Yun; King, Patrick K. [Department of Astronomy, University of Virginia, Charlottesville, VA 22904 (United States); Fissel, Laura M. [National Radio Astronomy Observatory, Charlottesville, VA 22904 (United States)

    2017-10-01

    Thin, magnetically aligned striations of relatively moderate contrast with the background are commonly observed in both atomic and molecular clouds. They are also prominent in MHD simulations with turbulent converging shocks. The simulated striations develop within a dense, stagnated sheet in the midplane of the post-shock region where magnetically induced converging flows collide. We show analytically that the secondary flows are an inevitable consequence of the jump conditions of oblique MHD shocks. They produce the stagnated, sheet-like sub-layer through a secondary shock when, roughly speaking, the Alfvénic speed in the primary converging flows is supersonic, a condition that is relatively easy to satisfy in interstellar clouds. The dense sub-layer is naturally threaded by a strong magnetic field that lies close to the plane of the sub-layer. The substantial magnetic field makes the sheet highly anisotropic, which is the key to the striation formation. Specifically, perturbations of the primary inflow that vary spatially perpendicular to the magnetic field can easily roll up the sheet around the field lines without bending them, creating corrugations that appear as magnetically aligned striations in column density maps. On the other hand, perturbations that vary spatially along the field lines curve the sub-layer and alter its orientation relative to the magnetic field locally, seeding special locations that become slanted overdense filaments and prestellar cores through enhanced mass accumulation along field lines. In our scenario, the dense sub-layer, which is unique to magnetized oblique shocks, is the birthplace for both magnetically aligned diffuse striations and massive star-forming structures.

  8. 10-channel fiber array fabrication technique for parallel optical coherence tomography system

    Science.gov (United States)

    Arauz, Lina J.; Luo, Yuan; Castillo, Jose E.; Kostuk, Raymond K.; Barton, Jennifer

    2007-02-01

    Optical Coherence Tomography (OCT) shows great promise for low intrusive biomedical imaging applications. A parallel OCT system is a novel technique that replaces mechanical transverse scanning with electronic scanning. This will reduce the time required to acquire image data. In this system an array of small diameter fibers is required to obtain an image in the transverse direction. Each fiber in the array is configured in an interferometer and is used to image one pixel in the transverse direction. In this paper we describe a technique to package 15μm diameter fibers on a siliconsilica substrate to be used in a 2mm endoscopic probe tip. Single mode fibers are etched to reduce the cladding diameter from 125μm to 15μm. Etched fibers are placed into a 4mm by 150μm trench in a silicon-silica substrate and secured with UV glue. Active alignment was used to simplify the lay out of the fibers and minimize unwanted horizontal displacement of the fibers. A 10-channel fiber array was built, tested and later incorporated into a parallel optical coherence system. This paper describes the packaging, testing, and operation of the array in a parallel OCT system.

  9. Beam plug replacement and alignment under high radiation conditions for cold neutron facilities at Hanaro

    International Nuclear Information System (INIS)

    Yeong-Garp, Cho; Jin-Won, Shin; Jung-Hee, Lee; Jeong-Soo, Ryu

    2010-01-01

    Full text : The HANARO, an open-tank-in-pool type research reactor of a 30 MWth power in Korea, has been operating for 15 years since its initial criticality in February 1995. The beam port assigned for the cold neutron at HANARO had been used for an 8-m SANS without neutron guides until it was replaced by a cold neutron guide system in 2008. It was developed a cold neutron guide system for the delivery of cold neutrons from the cold neutron source in the reactor to the neutron scattering instruments in the guide hall. Since the HANARO has been operated from 1995, it was a big challenge to replace the existing plug and shutter with the new facilities under high radiation conditions. When the old plug was removed from the beam port in 2008, the radiation level was 230 mSv/hr at the end of beam port. In addition to that, there were more difficult situations such as the poor as-built dimensions of the beam port, limited work space and time constraint due to other constructions in parallel in the reactor hall. Before the removal of the old plug the level of the radiation was measured coming out through a small hole of the plug to estimate the radiation level during the removal of the old plug and installation of a new plug. Based on the measurement and analysis results, special tools and various shielding facilities were developed for the removal of old in-pile plug and the installation of the new in-pile plug assembly safely. In 2008, the old plug and shutter were successfully replaced by the new plug and shutter as shown in this article with a minimum exposure to the workers. A laser tracker system was also one of the main factors in our successful installation and alignment under high radiation conditions and limited work space. The laser tracker was used to measure and align all the mechanical facilities and the neutron guides with a minimum radiation exposure to workers. The alignment of all the guides and accessories were possible during reactor operation because

  10. Parallel and Perpendicular Alignment of Anisotropic Particles in Free Liquid Microjets and Emerging Microdroplets.

    Science.gov (United States)

    Schlenk, Mathias; Hofmann, Eddie; Seibt, Susanne; Rosenfeldt, Sabine; Schrack, Lukas; Drechsler, Markus; Rothkirch, Andre; Ohm, Wiebke; Breu, Josef; Gekle, Stephan; Förster, Stephan

    2018-04-24

    Liquid microjets play a key role in fiber spinning, inkjet printing, and coating processes. In all of these applications, the liquid jets carry dispersed particles whose spatial and orientational distributions within the jet critically influence the properties of the fabricated structures. Despite its importance, there is currently no knowledge about the orientational distribution of particles within microjets and droplets. Here, we demonstrate a microfluidic device that allows to determine the local particle distribution and orientation by X-ray scattering. Using this methodology, we discovered unexpected changes in the particle orientation upon exiting the nozzle to form a free jet, and upon jet break-up into droplets, causing an unusual biaxial particle orientation. We show how flow and aspect ratio determine the flow orientation of anisotropic particles. Furthermore, we demonstrate that the observed phenomena are a general characteristic of anisotropic particles. Our findings greatly enhance our understanding of particle orientation in free jets and droplets and provide a rationale for controlling particle alignment in liquid jet-based fabrication methodologies.

  11. The parallel dynamics of drift wave turbulence in the WEGA stellarator

    Energy Technology Data Exchange (ETDEWEB)

    Marsen, S; Endler, M; Otte, M; Wagner, F, E-mail: stefan.marsen@ipp.mpg.d [Max-Planck-Institut fuer Plasmaphysik, EURATOM Association, Wendelsteinstrasse 1, 17491 Greifswald (Germany)

    2009-08-15

    The three-dimensional structure of turbulence in the edge (inside the last closed flux surface) of the WEGA stellarator is studied focusing on the parallel dynamics. WEGA as a small stellarator with moderate plasma parameters offers the opportunity to study turbulence with Langmuir probes providing high spatial and temporal resolution. Multiple probes with radial, poloidal and toroidal resolution are used to measure density fluctuations. Correlation analysis is used to reconstruct a 3D picture of turbulent structures. We find that these structures originate predominantly on the low field side and have a three-dimensional character with a finite averaged parallel wavenumber. The ratio between the parallel and perpendicular wavenumber component is in the order of 10{sup -2}. The parallel dynamics are compared at magnetic inductions of 57 and 500 mT. At 500 mT, the parallel wavelength is in the order of the field line connection length 2{pi}R{iota}-bar. A frequency resolved measure of k{sub ||}/k{sub {theta}} shows a constant ratio in this case. At 57 mT the observed k{sub ||} is much smaller than at 500 mT. However, the observed small average value is due to an averaging over positive and negative components pointing parallel and antiparallel to the magnetic field vector.

  12. Spray coating of self-aligning passivation layer for metal grid lines

    NARCIS (Netherlands)

    Vuorinen, T.; Janka, M.; Rubingh, J.E.J.M.; Tuukkanen, S.; Groen, P.; Lupo, D.

    2014-01-01

    In applications such as organic light emitting diodes (OLEDs) or photovoltaic cells a homogenous voltage distribution in the large anode layer needs to be ensured by including a metal grid with a transparent conductor layer. To ensure sufficient conductivity, relatively thick metal lines are used,

  13. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez and Y. Pakhotin

    2012-01-01

      A new track-based alignment for the DT chambers is ready for deployment: an offline tag has already been produced which will become part of the 52X Global Tag. This alignment was validated within the muon alignment group both at low and high momentum using a W/Z skim sample. It shows an improved mass resolution for pairs of stand-alone muons, improved curvature resolution at high momentum, and improved DT segment extrapolation residuals. The validation workflow for high-momentum muons used to depend solely on the “split cosmics” method, looking at the curvature difference between muon tracks reconstructed in the upper or lower half of CMS. The validation has now been extended to include energetic muons decaying from heavily boosted Zs: the di-muon invariant mass for global and stand-alone muons is reconstructed, and the invariant mass resolution is compared for different alignments. The main areas of development over the next few months will be preparing a new track-based C...

  14. Parallelization and implementation of approximate root isolation for nonlinear system by Monte Carlo

    Science.gov (United States)

    Khosravi, Ebrahim

    1998-12-01

    This dissertation solves a fundamental problem of isolating the real roots of nonlinear systems of equations by Monte-Carlo that were published by Bush Jones. This algorithm requires only function values and can be applied readily to complicated systems of transcendental functions. The implementation of this sequential algorithm provides scientists with the means to utilize function analysis in mathematics or other fields of science. The algorithm, however, is so computationally intensive that the system is limited to a very small set of variables, and this will make it unfeasible for large systems of equations. Also a computational technique was needed for investigating a metrology of preventing the algorithm structure from converging to the same root along different paths of computation. The research provides techniques for improving the efficiency and correctness of the algorithm. The sequential algorithm for this technique was corrected and a parallel algorithm is presented. This parallel method has been formally analyzed and is compared with other known methods of root isolation. The effectiveness, efficiency, enhanced overall performance of the parallel processing of the program in comparison to sequential processing is discussed. The message passing model was used for this parallel processing, and it is presented and implemented on Intel/860 MIMD architecture. The parallel processing proposed in this research has been implemented in an ongoing high energy physics experiment: this algorithm has been used to track neutrinoes in a super K detector. This experiment is located in Japan, and data can be processed on-line or off-line locally or remotely.

  15. Synthesis and electrical characterization of vertically-aligned ZnO–CuO hybrid nanowire p–n junctions

    International Nuclear Information System (INIS)

    Pukird, Supakorn; Song, Wooseok; Noothongkaew, Suttinart; Kim, Seong Ku; Min, Bok Ki; Kim, Seong Jun; Kim, Ki Woong; Myung, Sung; An, Ki-Seok

    2015-01-01

    Highlights: • Vertically-aligned ZnO–CuO hybrid nanowire arrays were synthesized by a two-step thermal chemical vapor deposition process. • The diameter of parallel-connected ZnO and CuO NWs were estimated to be 146 ± 12 nm and 55 ± 11 nm, respectively, and the formation of high-quality hexagonal ZnO and monoclinic CuO NWs were observed. • Clear rectifying behavior related with thermionic emission of carriers and the presence of an electrical potential barrier between the ZnO and CuO NWs were observed. - Abstract: In order to form nanowire (NW)-based p–n junctions, vertically-aligned ZnO–CuO hybrid NW arrays were synthesized by a two-step thermal chemical vapor deposition process. The diameter of parallel-connected ZnO and CuO NWs were estimated to be 146 ± 12 nm and 55 ± 11 nm, respectively, as observed by scanning electron microscopy. Chemical and structural characterizations of ZnO–CuO hybrid NW arrays were performed using X-ray photoelectron spectroscopy and X-ray diffraction, resulting in the formation of high-quality hexagonal ZnO and monoclinic CuO NWs. The temperature dependence of I–V curves and impedance spectra suggested that clear rectifying behavior related with thermionic emission of carriers and the presence of an electrical potential barrier between the ZnO and CuO NWs

  16. R3D Align web server for global nucleotide to nucleotide alignments of RNA 3D structures.

    Science.gov (United States)

    Rahrig, Ryan R; Petrov, Anton I; Leontis, Neocles B; Zirbel, Craig L

    2013-07-01

    The R3D Align web server provides online access to 'RNA 3D Align' (R3D Align), a method for producing accurate nucleotide-level structural alignments of RNA 3D structures. The web server provides a streamlined and intuitive interface, input data validation and output that is more extensive and easier to read and interpret than related servers. The R3D Align web server offers a unique Gallery of Featured Alignments, providing immediate access to pre-computed alignments of large RNA 3D structures, including all ribosomal RNAs, as well as guidance on effective use of the server and interpretation of the output. By accessing the non-redundant lists of RNA 3D structures provided by the Bowling Green State University RNA group, R3D Align connects users to structure files in the same equivalence class and the best-modeled representative structure from each group. The R3D Align web server is freely accessible at http://rna.bgsu.edu/r3dalign/.

  17. Aligned Layers of Silver Nano-Fibers

    Directory of Open Access Journals (Sweden)

    Andrii B. Golovin

    2012-02-01

    Full Text Available We describe a new dichroic polarizers made by ordering silver nano-fibers to aligned layers. The aligned layers consist of nano-fibers and self-assembled molecular aggregates of lyotropic liquid crystals. Unidirectional alignment of the layers is achieved by means of mechanical shearing. Aligned layers of silver nano-fibers are partially transparent to a linearly polarized electromagnetic radiation. The unidirectional alignment and density of the silver nano-fibers determine degree of polarization of transmitted light. The aligned layers of silver nano-fibers might be used in optics, microwave applications, and organic electronics.

  18. Sketch-based 3D modeling by aligning outlines of an image

    Directory of Open Access Journals (Sweden)

    Chunxiao Li

    2016-07-01

    Full Text Available In this paper we present an efficient technique for sketch-based 3D modeling using automatically extracted image features. Creating a 3D model often requires a drawing of irregular shapes composed of curved lines as a starting point but it is difficult to hand-draw such lines without introducing awkward bumps and edges along the lines. We propose an automatic alignment of a user׳s hand-drawn sketch lines to the contour lines of an image, facilitating a considerable level of ease with which the user can carelessly continue sketching while the system intelligently snaps the sketch lines to a background image contour, no longer requiring the strenuous effort and stress of trying to make a perfect line during the modeling task. This interactive technique seamlessly combines the efficiency and perception of the human user with the accuracy of computational power, applied to the domain of 3D modeling where the utmost precision of on-screen drawing has been one of the hurdles of the task hitherto considered a job requiring a highly skilled and careful manipulation by the user. We provide several examples to demonstrate the accuracy and efficiency of the method with which complex shapes were achieved easily and quickly in the interactive outline drawing task.

  19. Critical current density, irreversibility line, and flux creep activation energy in silver-sheathed Bi2Sr2Ca2Cu3Ox superconducting tapes

    International Nuclear Information System (INIS)

    Shi, D.; Wang, Z.; Sengupta, S.; Smith, M.; Goodrich, L.F.; Dou, S.X.; Liu, H.K.; Guo, Y.C.

    1992-08-01

    Transport data, magnetic hysteresis and flux creep activation energy experimental results are presented for silver-sheathed high-T c Bi 2 Sr 2 Ca 2 Cu 3 O x superconducting tapes. The 110 K superconducting phase was formed by lead doping in a Bi-Sr-Ca-Cu-0 system. The transport critical current density was measured at 4.0 K to be 0.7 x 10 5 A/cm 2 (the corresponding critical current is 74 A) at zero field and 1.6 x 10 4 A/cm 2 at 12 T for H parallel ab. Excellent grain alignment in the a-b plane was achieved by a short-melting method, which considerably improved the critical current density and irreversibility line. Flux creep activation energy as a function of current is obtained based on the magnetic relaxation measurements

  20. Parallel algorithm for determining motion vectors in ice floe images by matching edge features

    Science.gov (United States)

    Manohar, M.; Ramapriyan, H. K.; Strong, J. P.

    1988-01-01

    A parallel algorithm is described to determine motion vectors of ice floes using time sequences of images of the Arctic ocean obtained from the Synthetic Aperture Radar (SAR) instrument flown on-board the SEASAT spacecraft. Researchers describe a parallel algorithm which is implemented on the MPP for locating corresponding objects based on their translationally and rotationally invariant features. The algorithm first approximates the edges in the images by polygons or sets of connected straight-line segments. Each such edge structure is then reduced to a seed point. Associated with each seed point are the descriptions (lengths, orientations and sequence numbers) of the lines constituting the corresponding edge structure. A parallel matching algorithm is used to match packed arrays of such descriptions to identify corresponding seed points in the two images. The matching algorithm is designed such that fragmentation and merging of ice floes are taken into account by accepting partial matches. The technique has been demonstrated to work on synthetic test patterns and real image pairs from SEASAT in times ranging from .5 to 0.7 seconds for 128 x 128 images.