WorldWideScience

Sample records for accurate long-read alignment

  1. 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

  2. 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.

  3. YAHA: fast and flexible long-read alignment with optimal breakpoint detection.

    Science.gov (United States)

    Faust, Gregory G; Hall, Ira M

    2012-10-01

    With improved short-read assembly algorithms and the recent development of long-read sequencers, split mapping will soon be the preferred method for structural variant (SV) detection. Yet, current alignment tools are not well suited for this. We present YAHA, a fast and flexible hash-based aligner. YAHA is as fast and accurate as BWA-SW at finding the single best alignment per query and is dramatically faster and more sensitive than both SSAHA2 and MegaBLAST at finding all possible alignments. Unlike other aligners that report all, or one, alignment per query, or that use simple heuristics to select alignments, YAHA uses a directed acyclic graph to find the optimal set of alignments that cover a query using a biologically relevant breakpoint penalty. YAHA can also report multiple mappings per defined segment of the query. We show that YAHA detects more breakpoints in less time than BWA-SW across all SV classes, and especially excels at complex SVs comprising multiple breakpoints. YAHA is currently supported on 64-bit Linux systems. Binaries and sample data are freely available for download from http://faculty.virginia.edu/irahall/YAHA. imh4y@virginia.edu.

  4. BBMap: A Fast, Accurate, Splice-Aware Aligner

    Energy Technology Data Exchange (ETDEWEB)

    Bushnell, Brian

    2014-03-17

    Alignment of reads is one of the primary computational tasks in bioinformatics. Of paramount importance to resequencing, alignment is also crucial to other areas - quality control, scaffolding, string-graph assembly, homology detection, assembly evaluation, error-correction, expression quantification, and even as a tool to evaluate other tools. An optimal aligner would greatly improve virtually any sequencing process, but optimal alignment is prohibitively expensive for gigabases of data. Here, we will present BBMap [1], a fast splice-aware aligner for short and long reads. We will demonstrate that BBMap has superior speed, sensitivity, and specificity to alternative high-throughput aligners bowtie2 [2], bwa [3], smalt, [4] GSNAP [5], and BLASR [6].

  5. Concurrent and Accurate Short Read Mapping on Multicore Processors.

    Science.gov (United States)

    Martínez, Héctor; Tárraga, Joaquín; Medina, Ignacio; Barrachina, Sergio; Castillo, Maribel; Dopazo, Joaquín; Quintana-Ortí, Enrique S

    2015-01-01

    We introduce a parallel aligner with a work-flow organization for fast and accurate mapping of RNA sequences on servers equipped with multicore processors. Our software, HPG Aligner SA (HPG Aligner SA is an open-source application. The software is available at http://www.opencb.org, exploits a suffix array to rapidly map a large fraction of the RNA fragments (reads), as well as leverages the accuracy of the Smith-Waterman algorithm to deal with conflictive reads. The aligner is enhanced with a careful strategy to detect splice junctions based on an adaptive division of RNA reads into small segments (or seeds), which are then mapped onto a number of candidate alignment locations, providing crucial information for the successful alignment of the complete reads. The experimental results on a platform with Intel multicore technology report the parallel performance of HPG Aligner SA, on RNA reads of 100-400 nucleotides, which excels in execution time/sensitivity to state-of-the-art aligners such as TopHat 2+Bowtie 2, MapSplice, and STAR.

  6. Evaluating approaches to find exon chains based on long reads.

    Science.gov (United States)

    Kuosmanen, Anna; Norri, Tuukka; Mäkinen, Veli

    2018-05-01

    Transcript prediction can be modeled as a graph problem where exons are modeled as nodes and reads spanning two or more exons are modeled as exon chains. Pacific Biosciences third-generation sequencing technology produces significantly longer reads than earlier second-generation sequencing technologies, which gives valuable information about longer exon chains in a graph. However, with the high error rates of third-generation sequencing, aligning long reads correctly around the splice sites is a challenging task. Incorrect alignments lead to spurious nodes and arcs in the graph, which in turn lead to incorrect transcript predictions. We survey several approaches to find the exon chains corresponding to long reads in a splicing graph, and experimentally study the performance of these methods using simulated data to allow for sensitivity/precision analysis. Our experiments show that short reads from second-generation sequencing can be used to significantly improve exon chain correctness either by error-correcting the long reads before splicing graph creation, or by using them to create a splicing graph on which the long-read alignments are then projected. We also study the memory and time consumption of various modules, and show that accurate exon chains lead to significantly increased transcript prediction accuracy. The simulated data and in-house scripts used for this article are available at http://www.cs.helsinki.fi/group/gsa/exon-chains/exon-chains-bib.tar.bz2.

  7. libgapmis: extending short-read alignments.

    Science.gov (United States)

    Alachiotis, Nikolaos; Berger, Simon; Flouri, Tomáš; Pissis, Solon P; Stamatakis, Alexandros

    2013-01-01

    A wide variety of short-read alignment programmes have been published recently to tackle the problem of mapping millions of short reads to a reference genome, focusing on different aspects of the procedure such as time and memory efficiency, sensitivity, and accuracy. These tools allow for a small number of mismatches in the alignment; however, their ability to allow for gaps varies greatly, with many performing poorly or not allowing them at all. The seed-and-extend strategy is applied in most short-read alignment programmes. After aligning a substring of the reference sequence against the high-quality prefix of a short read--the seed--an important problem is to find the best possible alignment between a substring of the reference sequence succeeding and the remaining suffix of low quality of the read--extend. The fact that the reads are rather short and that the gap occurrence frequency observed in various studies is rather low suggest that aligning (parts of) those reads with a single gap is in fact desirable. In this article, we present libgapmis, a library for extending pairwise short-read alignments. Apart from the standard CPU version, it includes ultrafast SSE- and GPU-based implementations. libgapmis is based on an algorithm computing a modified version of the traditional dynamic-programming matrix for sequence alignment. Extensive experimental results demonstrate that the functions of the CPU version provided in this library accelerate the computations by a factor of 20 compared to other programmes. The analogous SSE- and GPU-based implementations accelerate the computations by a factor of 6 and 11, respectively, compared to the CPU version. The library also provides the user the flexibility to split the read into fragments, based on the observed gap occurrence frequency and the length of the read, thereby allowing for a variable, but bounded, number of gaps in the alignment. We present libgapmis, a library for extending pairwise short-read alignments. We

  8. How genome complexity can explain the difficulty of aligning reads to genomes.

    Science.gov (United States)

    Phan, Vinhthuy; Gao, Shanshan; Tran, Quang; Vo, Nam S

    2015-01-01

    Although it is frequently observed that aligning short reads to genomes becomes harder if they contain complex repeat patterns, there has not been much effort to quantify the relationship between complexity of genomes and difficulty of short-read alignment. Existing measures of sequence complexity seem unsuitable for the understanding and quantification of this relationship. We investigated several measures of complexity and found that length-sensitive measures of complexity had the highest correlation to accuracy of alignment. In particular, the rate of distinct substrings of length k, where k is similar to the read length, correlated very highly to alignment performance in terms of precision and recall. We showed how to compute this measure efficiently in linear time, making it useful in practice to estimate quickly the difficulty of alignment for new genomes without having to align reads to them first. We showed how the length-sensitive measures could provide additional information for choosing aligners that would align consistently accurately on new genomes. We formally established a connection between genome complexity and the accuracy of short-read aligners. The relationship between genome complexity and alignment accuracy provides additional useful information for selecting suitable aligners for new genomes. Further, this work suggests that the complexity of genomes sometimes should be thought of in terms of specific computational problems, such as the alignment of short reads to genomes.

  9. 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.

  10. Clustering of reads with alignment-free measures and quality values.

    Science.gov (United States)

    Comin, Matteo; Leoni, Andrea; Schimd, Michele

    2015-01-01

    The data volume generated by Next-Generation Sequencing (NGS) technologies is growing at a pace that is now challenging the storage and data processing capacities of modern computer systems. In this context an important aspect is the reduction of data complexity by collapsing redundant reads in a single cluster to improve the run time, memory requirements, and quality of post-processing steps like assembly and error correction. Several alignment-free measures, based on k-mers counts, have been used to cluster reads. Quality scores produced by NGS platforms are fundamental for various analysis of NGS data like reads mapping and error detection. Moreover future-generation sequencing platforms will produce long reads but with a large number of erroneous bases (up to 15 %). In this scenario it will be fundamental to exploit quality value information within the alignment-free framework. To the best of our knowledge this is the first study that incorporates quality value information and k-mers counts, in the context of alignment-free measures, for the comparison of reads data. Based on this principles, in this paper we present a family of alignment-free measures called D (q) -type. A set of experiments on simulated and real reads data confirms that the new measures are superior to other classical alignment-free statistics, especially when erroneous reads are considered. Also results on de novo assembly and metagenomic reads classification show that the introduction of quality values improves over standard alignment-free measures. These statistics are implemented in a software called QCluster (http://www.dei.unipd.it/~ciompin/main/qcluster.html).

  11. SAMMate: a GUI tool for processing short read alignments in SAM/BAM format

    Directory of Open Access Journals (Sweden)

    Flemington Erik

    2011-01-01

    Full Text Available Abstract Background Next Generation Sequencing (NGS technology generates tens of millions of short reads for each DNA/RNA sample. A key step in NGS data analysis is the short read alignment of the generated sequences to a reference genome. Although storing alignment information in the Sequence Alignment/Map (SAM or Binary SAM (BAM format is now standard, biomedical researchers still have difficulty accessing this information. Results We have developed a Graphical User Interface (GUI software tool named SAMMate. SAMMate allows biomedical researchers to quickly process SAM/BAM files and is compatible with both single-end and paired-end sequencing technologies. SAMMate also automates some standard procedures in DNA-seq and RNA-seq data analysis. Using either standard or customized annotation files, SAMMate allows users to accurately calculate the short read coverage of genomic intervals. In particular, for RNA-seq data SAMMate can accurately calculate the gene expression abundance scores for customized genomic intervals using short reads originating from both exons and exon-exon junctions. Furthermore, SAMMate can quickly calculate a whole-genome signal map at base-wise resolution allowing researchers to solve an array of bioinformatics problems. Finally, SAMMate can export both a wiggle file for alignment visualization in the UCSC genome browser and an alignment statistics report. The biological impact of these features is demonstrated via several case studies that predict miRNA targets using short read alignment information files. Conclusions With just a few mouse clicks, SAMMate will provide biomedical researchers easy access to important alignment information stored in SAM/BAM files. Our software is constantly updated and will greatly facilitate the downstream analysis of NGS data. Both the source code and the GUI executable are freely available under the GNU General Public License at http://sammate.sourceforge.net.

  12. Accurate estimation of short read mapping quality for next-generation genome sequencing

    Science.gov (United States)

    Ruffalo, Matthew; Koyutürk, Mehmet; Ray, Soumya; LaFramboise, Thomas

    2012-01-01

    Motivation: Several software tools specialize in the alignment of short next-generation sequencing reads to a reference sequence. Some of these tools report a mapping quality score for each alignment—in principle, this quality score tells researchers the likelihood that the alignment is correct. However, the reported mapping quality often correlates weakly with actual accuracy and the qualities of many mappings are underestimated, encouraging the researchers to discard correct mappings. Further, these low-quality mappings tend to correlate with variations in the genome (both single nucleotide and structural), and such mappings are important in accurately identifying genomic variants. Approach: We develop a machine learning tool, LoQuM (LOgistic regression tool for calibrating the Quality of short read mappings, to assign reliable mapping quality scores to mappings of Illumina reads returned by any alignment tool. LoQuM uses statistics on the read (base quality scores reported by the sequencer) and the alignment (number of matches, mismatches and deletions, mapping quality score returned by the alignment tool, if available, and number of mappings) as features for classification and uses simulated reads to learn a logistic regression model that relates these features to actual mapping quality. Results: We test the predictions of LoQuM on an independent dataset generated by the ART short read simulation software and observe that LoQuM can ‘resurrect’ many mappings that are assigned zero quality scores by the alignment tools and are therefore likely to be discarded by researchers. We also observe that the recalibration of mapping quality scores greatly enhances the precision of called single nucleotide polymorphisms. Availability: LoQuM is available as open source at http://compbio.case.edu/loqum/. Contact: matthew.ruffalo@case.edu. PMID:22962451

  13. 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.

  14. Introducing difference recurrence relations for faster semi-global alignment of long sequences.

    Science.gov (United States)

    Suzuki, Hajime; Kasahara, Masahiro

    2018-02-19

    The read length of single-molecule DNA sequencers is reaching 1 Mb. Popular alignment software tools widely used for analyzing such long reads often take advantage of single-instruction multiple-data (SIMD) operations to accelerate calculation of dynamic programming (DP) matrices in the Smith-Waterman-Gotoh (SWG) algorithm with a fixed alignment start position at the origin. Nonetheless, 16-bit or 32-bit integers are necessary for storing the values in a DP matrix when sequences to be aligned are long; this situation hampers the use of the full SIMD width of modern processors. We proposed a faster semi-global alignment algorithm, "difference recurrence relations," that runs more rapidly than the state-of-the-art algorithm by a factor of 2.1. Instead of calculating and storing all the values in a DP matrix directly, our algorithm computes and stores mainly the differences between the values of adjacent cells in the matrix. Although the SWG algorithm and our algorithm can output exactly the same result, our algorithm mainly involves 8-bit integer operations, enabling us to exploit the full width of SIMD operations (e.g., 32) on modern processors. We also developed a library, libgaba, so that developers can easily integrate our algorithm into alignment programs. Our novel algorithm and optimized library implementation will facilitate accelerating nucleotide long-read analysis algorithms that use pairwise alignment stages. The library is implemented in the C programming language and available at https://github.com/ocxtal/libgaba .

  15. Easy and accurate reconstruction of whole HIV genomes from short-read sequence data with shiver

    Science.gov (United States)

    Blanquart, François; Golubchik, Tanya; Gall, Astrid; Bakker, Margreet; Bezemer, Daniela; Croucher, Nicholas J; Hall, Matthew; Hillebregt, Mariska; Ratmann, Oliver; Albert, Jan; Bannert, Norbert; Fellay, Jacques; Fransen, Katrien; Gourlay, Annabelle; Grabowski, M Kate; Gunsenheimer-Bartmeyer, Barbara; Günthard, Huldrych F; Kivelä, Pia; Kouyos, Roger; Laeyendecker, Oliver; Liitsola, Kirsi; Meyer, Laurence; Porter, Kholoud; Ristola, Matti; van Sighem, Ard; Cornelissen, Marion; Kellam, Paul; Reiss, Peter

    2018-01-01

    Abstract Studying the evolution of viruses and their molecular epidemiology relies on accurate viral sequence data, so that small differences between similar viruses can be meaningfully interpreted. Despite its higher throughput and more detailed minority variant data, next-generation sequencing has yet to be widely adopted for HIV. The difficulty of accurately reconstructing the consensus sequence of a quasispecies from reads (short fragments of DNA) in the presence of large between- and within-host diversity, including frequent indels, may have presented a barrier. In particular, mapping (aligning) reads to a reference sequence leads to biased loss of information; this bias can distort epidemiological and evolutionary conclusions. De novo assembly avoids this bias by aligning the reads to themselves, producing a set of sequences called contigs. However contigs provide only a partial summary of the reads, misassembly may result in their having an incorrect structure, and no information is available at parts of the genome where contigs could not be assembled. To address these problems we developed the tool shiver to pre-process reads for quality and contamination, then map them to a reference tailored to the sample using corrected contigs supplemented with the user’s choice of existing reference sequences. Run with two commands per sample, it can easily be used for large heterogeneous data sets. We used shiver to reconstruct the consensus sequence and minority variant information from paired-end short-read whole-genome data produced with the Illumina platform, for sixty-five existing publicly available samples and fifty new samples. We show the systematic superiority of mapping to shiver’s constructed reference compared with mapping the same reads to the closest of 3,249 real references: median values of 13 bases called differently and more accurately, 0 bases called differently and less accurately, and 205 bases of missing sequence recovered. We also

  16. Alignment of Short Reads: A Crucial Step for Application of Next-Generation Sequencing Data in Precision Medicine

    Directory of Open Access Journals (Sweden)

    Hao Ye

    2015-11-01

    Full Text Available Precision medicine or personalized medicine has been proposed as a modernized and promising medical strategy. Genetic variants of patients are the key information for implementation of precision medicine. Next-generation sequencing (NGS is an emerging technology for deciphering genetic variants. Alignment of raw reads to a reference genome is one of the key steps in NGS data analysis. Many algorithms have been developed for alignment of short read sequences since 2008. Users have to make a decision on which alignment algorithm to use in their studies. Selection of the right alignment algorithm determines not only the alignment algorithm but also the set of suitable parameters to be used by the algorithm. Understanding these algorithms helps in selecting the appropriate alignment algorithm for different applications in precision medicine. Here, we review current available algorithms and their major strategies such as seed-and-extend and q-gram filter. We also discuss the challenges in current alignment algorithms, including alignment in multiple repeated regions, long reads alignment and alignment facilitated with known genetic variants.

  17. Accurate Alignment of Plasma Channels Based on Laser Centroid Oscillations

    International Nuclear Information System (INIS)

    Gonsalves, Anthony; Nakamura, Kei; Lin, Chen; Osterhoff, Jens; Shiraishi, Satomi; Schroeder, Carl; Geddes, Cameron; Toth, Csaba; Esarey, Eric; Leemans, Wim

    2011-01-01

    A technique has been developed to accurately align a laser beam through a plasma channel by minimizing the shift in laser centroid and angle at the channel outptut. If only the shift in centroid or angle is measured, then accurate alignment is provided by minimizing laser centroid motion at the channel exit as the channel properties are scanned. The improvement in alignment accuracy provided by this technique is important for minimizing electron beam pointing errors in laser plasma accelerators.

  18. FMLRC: Hybrid long read error correction using an FM-index.

    Science.gov (United States)

    Wang, Jeremy R; Holt, James; McMillan, Leonard; Jones, Corbin D

    2018-02-09

    Long read sequencing is changing the landscape of genomic research, especially de novo assembly. Despite the high error rate inherent to long read technologies, increased read lengths dramatically improve the continuity and accuracy of genome assemblies. However, the cost and throughput of these technologies limits their application to complex genomes. One solution is to decrease the cost and time to assemble novel genomes by leveraging "hybrid" assemblies that use long reads for scaffolding and short reads for accuracy. We describe a novel method leveraging a multi-string Burrows-Wheeler Transform with auxiliary FM-index to correct errors in long read sequences using a set of complementary short reads. We demonstrate that our method efficiently produces significantly more high quality corrected sequence than existing hybrid error-correction methods. We also show that our method produces more contiguous assemblies, in many cases, than existing state-of-the-art hybrid and long-read only de novo assembly methods. Our method accurately corrects long read sequence data using complementary short reads. We demonstrate higher total throughput of corrected long reads and a corresponding increase in contiguity of the resulting de novo assemblies. Improved throughput and computational efficiency than existing methods will help better economically utilize emerging long read sequencing technologies.

  19. Nonhybrid, finished microbial genome assemblies from long-read SMRT sequencing data.

    Science.gov (United States)

    Chin, Chen-Shan; Alexander, David H; Marks, Patrick; Klammer, Aaron A; Drake, James; Heiner, Cheryl; Clum, Alicia; Copeland, Alex; Huddleston, John; Eichler, Evan E; Turner, Stephen W; Korlach, Jonas

    2013-06-01

    We present a hierarchical genome-assembly process (HGAP) for high-quality de novo microbial genome assemblies using only a single, long-insert shotgun DNA library in conjunction with Single Molecule, Real-Time (SMRT) DNA sequencing. Our method uses the longest reads as seeds to recruit all other reads for construction of highly accurate preassembled reads through a directed acyclic graph-based consensus procedure, which we follow with assembly using off-the-shelf long-read assemblers. In contrast to hybrid approaches, HGAP does not require highly accurate raw reads for error correction. We demonstrate efficient genome assembly for several microorganisms using as few as three SMRT Cell zero-mode waveguide arrays of sequencing and for BACs using just one SMRT Cell. Long repeat regions can be successfully resolved with this workflow. We also describe a consensus algorithm that incorporates SMRT sequencing primary quality values to produce de novo genome sequence exceeding 99.999% accuracy.

  20. NINJA-OPS: Fast Accurate Marker Gene Alignment Using Concatenated Ribosomes.

    Directory of Open Access Journals (Sweden)

    Gabriel A Al-Ghalith

    2016-01-01

    Full Text Available The explosion of bioinformatics technologies in the form of next generation sequencing (NGS has facilitated a massive influx of genomics data in the form of short reads. Short read mapping is therefore a fundamental component of next generation sequencing pipelines which routinely match these short reads against reference genomes for contig assembly. However, such techniques have seldom been applied to microbial marker gene sequencing studies, which have mostly relied on novel heuristic approaches. We propose NINJA Is Not Just Another OTU-Picking Solution (NINJA-OPS, or NINJA for short, a fast and highly accurate novel method enabling reference-based marker gene matching (picking Operational Taxonomic Units, or OTUs. NINJA takes advantage of the Burrows-Wheeler (BW alignment using an artificial reference chromosome composed of concatenated reference sequences, the "concatesome," as the BW input. Other features include automatic support for paired-end reads with arbitrary insert sizes. NINJA is also free and open source and implements several pre-filtering methods that elicit substantial speedup when coupled with existing tools. We applied NINJA to several published microbiome studies, obtaining accuracy similar to or better than previous reference-based OTU-picking methods while achieving an order of magnitude or more speedup and using a fraction of the memory footprint. NINJA is a complete pipeline that takes a FASTA-formatted input file and outputs a QIIME-formatted taxonomy-annotated BIOM file for an entire MiSeq run of human gut microbiome 16S genes in under 10 minutes on a dual-core laptop.

  1. A Fast Approximate Algorithm for Mapping Long Reads to Large Reference Databases.

    Science.gov (United States)

    Jain, Chirag; Dilthey, Alexander; Koren, Sergey; Aluru, Srinivas; Phillippy, Adam M

    2018-04-30

    Emerging single-molecule sequencing technologies from Pacific Biosciences and Oxford Nanopore have revived interest in long-read mapping algorithms. Alignment-based seed-and-extend methods demonstrate good accuracy, but face limited scalability, while faster alignment-free methods typically trade decreased precision for efficiency. In this article, we combine a fast approximate read mapping algorithm based on minimizers with a novel MinHash identity estimation technique to achieve both scalability and precision. In contrast to prior methods, we develop a mathematical framework that defines the types of mapping targets we uncover, establish probabilistic estimates of p-value and sensitivity, and demonstrate tolerance for alignment error rates up to 20%. With this framework, our algorithm automatically adapts to different minimum length and identity requirements and provides both positional and identity estimates for each mapping reported. For mapping human PacBio reads to the hg38 reference, our method is 290 × faster than Burrows-Wheeler Aligner-MEM with a lower memory footprint and recall rate of 96%. We further demonstrate the scalability of our method by mapping noisy PacBio reads (each ≥5 kbp in length) to the complete NCBI RefSeq database containing 838 Gbp of sequence and >60,000 genomes.

  2. 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.

  3. SOAP2: an improved ultrafast tool for short read alignment

    DEFF Research Database (Denmark)

    Li, Ruiqiang; Yu, Chang; Li, Yingrui

    2009-01-01

    SUMMARY: SOAP2 is a significantly improved version of the short oligonucleotide alignment program that both reduces computer memory usage and increases alignment speed at an unprecedented rate. We used a Burrows Wheeler Transformation (BWT) compression index to substitute the seed strategy...... for indexing the reference sequence in the main memory. We tested it on the whole human genome and found that this new algorithm reduced memory usage from 14.7 to 5.4 GB and improved alignment speed by 20-30 times. SOAP2 is compatible with both single- and paired-end reads. Additionally, this tool now supports...... multiple text and compressed file formats. A consensus builder has also been developed for consensus assembly and SNP detection from alignment of short reads on a reference genome. AVAILABILITY: http://soap.genomics.org.cn....

  4. Predicting RNA hyper-editing with a novel tool when unambiguous alignment is impossible.

    Science.gov (United States)

    McKerrow, Wilson H; Savva, Yiannis A; Rezaei, Ali; Reenan, Robert A; Lawrence, Charles E

    2017-07-10

    Repetitive elements are now known to have relevant cellular functions, including self-complementary sequences that form double stranded (ds) RNA. There are numerous pathways that determine the fate of endogenous dsRNA, and misregulation of endogenous dsRNA is a driver of autoimmune disease, particularly in the brain. Unfortunately, the alignment of high-throughput, short-read sequences to repeat elements poses a dilemma: Such sequences may align equally well to multiple genomic locations. In order to differentiate repeat elements, current alignment methods depend on sequence variation in the reference genome. Reads are discarded when no such variations are present. However, RNA hyper-editing, a possible fate for dsRNA, introduces enough variation to distinguish between repeats that are otherwise identical. To take advantage of this variation, we developed a new algorithm, RepProfile, that simultaneously aligns reads and predicts novel variations. RepProfile accurately aligns hyper-edited reads that other methods discard. In particular we predict hyper-editing of Drosophila melanogaster repeat elements in vivo at levels previously described only in vitro, and provide validation by Sanger sequencing sixty-two individual cloned sequences. We find that hyper-editing is concentrated in genes involved in cell-cell communication at the synapse, including some that are associated with neurodegeneration. We also find that hyper-editing tends to occur in short runs. Previous studies of RNA hyper-editing discarded ambiguously aligned reads, ignoring hyper-editing in long, perfect dsRNA - the perfect substrate for hyper-editing. We provide a method that simulation and Sanger validation show accurately predicts such RNA editing, yielding a superior picture of hyper-editing.

  5. Specificity control for read alignments using an artificial reference genome-guided false discovery rate.

    Science.gov (United States)

    Giese, Sven H; Zickmann, Franziska; Renard, Bernhard Y

    2014-01-01

    Accurate estimation, comparison and evaluation of read mapping error rates is a crucial step in the processing of next-generation sequencing data, as further analysis steps and interpretation assume the correctness of the mapping results. Current approaches are either focused on sensitivity estimation and thereby disregard specificity or are based on read simulations. Although continuously improving, read simulations are still prone to introduce a bias into the mapping error quantitation and cannot capture all characteristics of an individual dataset. We introduce ARDEN (artificial reference driven estimation of false positives in next-generation sequencing data), a novel benchmark method that estimates error rates of read mappers based on real experimental reads, using an additionally generated artificial reference genome. It allows a dataset-specific computation of error rates and the construction of a receiver operating characteristic curve. Thereby, it can be used for optimization of parameters for read mappers, selection of read mappers for a specific problem or for filtering alignments based on quality estimation. The use of ARDEN is demonstrated in a general read mapper comparison, a parameter optimization for one read mapper and an application example in single-nucleotide polymorphism discovery with a significant reduction in the number of false positive identifications. The ARDEN source code is freely available at http://sourceforge.net/projects/arden/.

  6. Pairagon: a highly accurate, HMM-based cDNA-to-genome aligner.

    Science.gov (United States)

    Lu, David V; Brown, Randall H; Arumugam, Manimozhiyan; Brent, Michael R

    2009-07-01

    The most accurate way to determine the intron-exon structures in a genome is to align spliced cDNA sequences to the genome. Thus, cDNA-to-genome alignment programs are a key component of most annotation pipelines. The scoring system used to choose the best alignment is a primary determinant of alignment accuracy, while heuristics that prevent consideration of certain alignments are a primary determinant of runtime and memory usage. Both accuracy and speed are important considerations in choosing an alignment algorithm, but scoring systems have received much less attention than heuristics. We present Pairagon, a pair hidden Markov model based cDNA-to-genome alignment program, as the most accurate aligner for sequences with high- and low-identity levels. We conducted a series of experiments testing alignment accuracy with varying sequence identity. We first created 'perfect' simulated cDNA sequences by splicing the sequences of exons in the reference genome sequences of fly and human. The complete reference genome sequences were then mutated to various degrees using a realistic mutation simulator and the perfect cDNAs were aligned to them using Pairagon and 12 other aligners. To validate these results with natural sequences, we performed cross-species alignment using orthologous transcripts from human, mouse and rat. We found that aligner accuracy is heavily dependent on sequence identity. For sequences with 100% identity, Pairagon achieved accuracy levels of >99.6%, with one quarter of the errors of any other aligner. Furthermore, for human/mouse alignments, which are only 85% identical, Pairagon achieved 87% accuracy, higher than any other aligner. Pairagon source and executables are freely available at http://mblab.wustl.edu/software/pairagon/

  7. Pairagon: a highly accurate, HMM-based cDNA-to-genome aligner

    DEFF Research Database (Denmark)

    Lu, David V; Brown, Randall H; Arumugam, Manimozhiyan

    2009-01-01

    MOTIVATION: The most accurate way to determine the intron-exon structures in a genome is to align spliced cDNA sequences to the genome. Thus, cDNA-to-genome alignment programs are a key component of most annotation pipelines. The scoring system used to choose the best alignment is a primary...... determinant of alignment accuracy, while heuristics that prevent consideration of certain alignments are a primary determinant of runtime and memory usage. Both accuracy and speed are important considerations in choosing an alignment algorithm, but scoring systems have received much less attention than...

  8. A rank-based sequence aligner with applications in phylogenetic analysis.

    Directory of Open Access Journals (Sweden)

    Liviu P Dinu

    Full Text Available Recent tools for aligning short DNA reads have been designed to optimize the trade-off between correctness and speed. This paper introduces a method for assigning a set of short DNA reads to a reference genome, under Local Rank Distance (LRD. The rank-based aligner proposed in this work aims to improve correctness over speed. However, some indexing strategies to speed up the aligner are also investigated. The LRD aligner is improved in terms of speed by storing [Formula: see text]-mer positions in a hash table for each read. Another improvement, that produces an approximate LRD aligner, is to consider only the positions in the reference that are likely to represent a good positional match of the read. The proposed aligner is evaluated and compared to other state of the art alignment tools in several experiments. A set of experiments are conducted to determine the precision and the recall of the proposed aligner, in the presence of contaminated reads. In another set of experiments, the proposed aligner is used to find the order, the family, or the species of a new (or unknown organism, given only a set of short Next-Generation Sequencing DNA reads. The empirical results show that the aligner proposed in this work is highly accurate from a biological point of view. Compared to the other evaluated tools, the LRD aligner has the important advantage of being very accurate even for a very low base coverage. Thus, the LRD aligner can be considered as a good alternative to standard alignment tools, especially when the accuracy of the aligner is of high importance. Source code and UNIX binaries of the aligner are freely available for future development and use at http://lrd.herokuapp.com/aligners. The software is implemented in C++ and Java, being supported on UNIX and MS Windows.

  9. SATe-II: very fast and accurate simultaneous estimation of multiple sequence alignments and phylogenetic trees.

    Science.gov (United States)

    Liu, Kevin; Warnow, Tandy J; Holder, Mark T; Nelesen, Serita M; Yu, Jiaye; Stamatakis, Alexandros P; Linder, C Randal

    2012-01-01

    Highly accurate estimation of phylogenetic trees for large data sets is difficult, in part because multiple sequence alignments must be accurate for phylogeny estimation methods to be accurate. Coestimation of alignments and trees has been attempted but currently only SATé estimates reasonably accurate trees and alignments for large data sets in practical time frames (Liu K., Raghavan S., Nelesen S., Linder C.R., Warnow T. 2009b. Rapid and accurate large-scale coestimation of sequence alignments and phylogenetic trees. Science. 324:1561-1564). Here, we present a modification to the original SATé algorithm that improves upon SATé (which we now call SATé-I) in terms of speed and of phylogenetic and alignment accuracy. SATé-II uses a different divide-and-conquer strategy than SATé-I and so produces smaller more closely related subsets than SATé-I; as a result, SATé-II produces more accurate alignments and trees, can analyze larger data sets, and runs more efficiently than SATé-I. Generally, SATé is a metamethod that takes an existing multiple sequence alignment method as an input parameter and boosts the quality of that alignment method. SATé-II-boosted alignment methods are significantly more accurate than their unboosted versions, and trees based upon these improved alignments are more accurate than trees based upon the original alignments. Because SATé-I used maximum likelihood (ML) methods that treat gaps as missing data to estimate trees and because we found a correlation between the quality of tree/alignment pairs and ML scores, we explored the degree to which SATé's performance depends on using ML with gaps treated as missing data to determine the best tree/alignment pair. We present two lines of evidence that using ML with gaps treated as missing data to optimize the alignment and tree produces very poor results. First, we show that the optimization problem where a set of unaligned DNA sequences is given and the output is the tree and alignment of

  10. Genometa--a fast and accurate classifier for short metagenomic shotgun reads.

    Science.gov (United States)

    Davenport, Colin F; Neugebauer, Jens; Beckmann, Nils; Friedrich, Benedikt; Kameri, Burim; Kokott, Svea; Paetow, Malte; Siekmann, Björn; Wieding-Drewes, Matthias; Wienhöfer, Markus; Wolf, Stefan; Tümmler, Burkhard; Ahlers, Volker; Sprengel, Frauke

    2012-01-01

    Metagenomic studies use high-throughput sequence data to investigate microbial communities in situ. However, considerable challenges remain in the analysis of these data, particularly with regard to speed and reliable analysis of microbial species as opposed to higher level taxa such as phyla. We here present Genometa, a computationally undemanding graphical user interface program that enables identification of bacterial species and gene content from datasets generated by inexpensive high-throughput short read sequencing technologies. Our approach was first verified on two simulated metagenomic short read datasets, detecting 100% and 94% of the bacterial species included with few false positives or false negatives. Subsequent comparative benchmarking analysis against three popular metagenomic algorithms on an Illumina human gut dataset revealed Genometa to attribute the most reads to bacteria at species level (i.e. including all strains of that species) and demonstrate similar or better accuracy than the other programs. Lastly, speed was demonstrated to be many times that of BLAST due to the use of modern short read aligners. Our method is highly accurate if bacteria in the sample are represented by genomes in the reference sequence but cannot find species absent from the reference. This method is one of the most user-friendly and resource efficient approaches and is thus feasible for rapidly analysing millions of short reads on a personal computer. The Genometa program, a step by step tutorial and Java source code are freely available from http://genomics1.mh-hannover.de/genometa/ and on http://code.google.com/p/genometa/. This program has been tested on Ubuntu Linux and Windows XP/7.

  11. Genometa--a fast and accurate classifier for short metagenomic shotgun reads.

    Directory of Open Access Journals (Sweden)

    Colin F Davenport

    Full Text Available Metagenomic studies use high-throughput sequence data to investigate microbial communities in situ. However, considerable challenges remain in the analysis of these data, particularly with regard to speed and reliable analysis of microbial species as opposed to higher level taxa such as phyla. We here present Genometa, a computationally undemanding graphical user interface program that enables identification of bacterial species and gene content from datasets generated by inexpensive high-throughput short read sequencing technologies. Our approach was first verified on two simulated metagenomic short read datasets, detecting 100% and 94% of the bacterial species included with few false positives or false negatives. Subsequent comparative benchmarking analysis against three popular metagenomic algorithms on an Illumina human gut dataset revealed Genometa to attribute the most reads to bacteria at species level (i.e. including all strains of that species and demonstrate similar or better accuracy than the other programs. Lastly, speed was demonstrated to be many times that of BLAST due to the use of modern short read aligners. Our method is highly accurate if bacteria in the sample are represented by genomes in the reference sequence but cannot find species absent from the reference. This method is one of the most user-friendly and resource efficient approaches and is thus feasible for rapidly analysing millions of short reads on a personal computer.The Genometa program, a step by step tutorial and Java source code are freely available from http://genomics1.mh-hannover.de/genometa/ and on http://code.google.com/p/genometa/. This program has been tested on Ubuntu Linux and Windows XP/7.

  12. 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

  13. 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

  14. Evaluation of microRNA alignment techniques

    Science.gov (United States)

    Kaspi, Antony; El-Osta, Assam

    2016-01-01

    Genomic alignment of small RNA (smRNA) sequences such as microRNAs poses considerable challenges due to their short length (∼21 nucleotides [nt]) as well as the large size and complexity of plant and animal genomes. While several tools have been developed for high-throughput mapping of longer mRNA-seq reads (>30 nt), there are few that are specifically designed for mapping of smRNA reads including microRNAs. The accuracy of these mappers has not been systematically determined in the case of smRNA-seq. In addition, it is unknown whether these aligners accurately map smRNA reads containing sequence errors and polymorphisms. By using simulated read sets, we determine the alignment sensitivity and accuracy of 16 short-read mappers and quantify their robustness to mismatches, indels, and nontemplated nucleotide additions. These were explored in the context of a plant genome (Oryza sativa, ∼500 Mbp) and a mammalian genome (Homo sapiens, ∼3.1 Gbp). Analysis of simulated and real smRNA-seq data demonstrates that mapper selection impacts differential expression results and interpretation. These results will inform on best practice for smRNA mapping and enable more accurate smRNA detection and quantification of expression and RNA editing. PMID:27284164

  15. A hybrid cloud read aligner based on MinHash and kmer voting that preserves privacy

    Science.gov (United States)

    Popic, Victoria; Batzoglou, Serafim

    2017-05-01

    Low-cost clouds can alleviate the compute and storage burden of the genome sequencing data explosion. However, moving personal genome data analysis to the cloud can raise serious privacy concerns. Here, we devise a method named Balaur, a privacy preserving read mapper for hybrid clouds based on locality sensitive hashing and kmer voting. Balaur can securely outsource a substantial fraction of the computation to the public cloud, while being highly competitive in accuracy and speed with non-private state-of-the-art read aligners on short read data. We also show that the method is significantly faster than the state of the art in long read mapping. Therefore, Balaur can enable institutions handling massive genomic data sets to shift part of their analysis to the cloud without sacrificing accuracy or exposing sensitive information to an untrusted third party.

  16. Leveraging FPGAs for Accelerating Short Read Alignment.

    Science.gov (United States)

    Arram, James; Kaplan, Thomas; Luk, Wayne; Jiang, Peiyong

    2017-01-01

    One of the key challenges facing genomics today is how to efficiently analyze the massive amounts of data produced by next-generation sequencing platforms. With general-purpose computing systems struggling to address this challenge, specialized processors such as the Field-Programmable Gate Array (FPGA) are receiving growing interest. The means by which to leverage this technology for accelerating genomic data analysis is however largely unexplored. In this paper, we present a runtime reconfigurable architecture for accelerating short read alignment using FPGAs. This architecture exploits the reconfigurability of FPGAs to allow the development of fast yet flexible alignment designs. We apply this architecture to develop an alignment design which supports exact and approximate alignment with up to two mismatches. Our design is based on the FM-index, with optimizations to improve the alignment performance. In particular, the n-step FM-index, index oversampling, a seed-and-compare stage, and bi-directional backtracking are included. Our design is implemented and evaluated on a 1U Maxeler MPC-X2000 dataflow node with eight Altera Stratix-V FPGAs. Measurements show that our design is 28 times faster than Bowtie2 running with 16 threads on dual Intel Xeon E5-2640 CPUs, and nine times faster than Soap3-dp running on an NVIDIA Tesla C2070 GPU.

  17. Accurate and robust brain image alignment using boundary-based registration.

    Science.gov (United States)

    Greve, Douglas N; Fischl, Bruce

    2009-10-15

    The fine spatial scales of the structures in the human brain represent an enormous challenge to the successful integration of information from different images for both within- and between-subject analysis. While many algorithms to register image pairs from the same subject exist, visual inspection shows that their accuracy and robustness to be suspect, particularly when there are strong intensity gradients and/or only part of the brain is imaged. This paper introduces a new algorithm called Boundary-Based Registration, or BBR. The novelty of BBR is that it treats the two images very differently. The reference image must be of sufficient resolution and quality to extract surfaces that separate tissue types. The input image is then aligned to the reference by maximizing the intensity gradient across tissue boundaries. Several lower quality images can be aligned through their alignment with the reference. Visual inspection and fMRI results show that BBR is more accurate than correlation ratio or normalized mutual information and is considerably more robust to even strong intensity inhomogeneities. BBR also excels at aligning partial-brain images to whole-brain images, a domain in which existing registration algorithms frequently fail. Even in the limit of registering a single slice, we show the BBR results to be robust and accurate.

  18. AlignerBoost: A Generalized Software Toolkit for Boosting Next-Gen Sequencing Mapping Accuracy Using a Bayesian-Based Mapping Quality Framework.

    Directory of Open Access Journals (Sweden)

    Qi Zheng

    2016-10-01

    Full Text Available Accurate mapping of next-generation sequencing (NGS reads to reference genomes is crucial for almost all NGS applications and downstream analyses. Various repetitive elements in human and other higher eukaryotic genomes contribute in large part to ambiguously (non-uniquely mapped reads. Most available NGS aligners attempt to address this by either removing all non-uniquely mapping reads, or reporting one random or "best" hit based on simple heuristics. Accurate estimation of the mapping quality of NGS reads is therefore critical albeit completely lacking at present. Here we developed a generalized software toolkit "AlignerBoost", which utilizes a Bayesian-based framework to accurately estimate mapping quality of ambiguously mapped NGS reads. We tested AlignerBoost with both simulated and real DNA-seq and RNA-seq datasets at various thresholds. In most cases, but especially for reads falling within repetitive regions, AlignerBoost dramatically increases the mapping precision of modern NGS aligners without significantly compromising the sensitivity even without mapping quality filters. When using higher mapping quality cutoffs, AlignerBoost achieves a much lower false mapping rate while exhibiting comparable or higher sensitivity compared to the aligner default modes, therefore significantly boosting the detection power of NGS aligners even using extreme thresholds. AlignerBoost is also SNP-aware, and higher quality alignments can be achieved if provided with known SNPs. AlignerBoost's algorithm is computationally efficient, and can process one million alignments within 30 seconds on a typical desktop computer. AlignerBoost is implemented as a uniform Java application and is freely available at https://github.com/Grice-Lab/AlignerBoost.

  19. AlignerBoost: A Generalized Software Toolkit for Boosting Next-Gen Sequencing Mapping Accuracy Using a Bayesian-Based Mapping Quality Framework.

    Science.gov (United States)

    Zheng, Qi; Grice, Elizabeth A

    2016-10-01

    Accurate mapping of next-generation sequencing (NGS) reads to reference genomes is crucial for almost all NGS applications and downstream analyses. Various repetitive elements in human and other higher eukaryotic genomes contribute in large part to ambiguously (non-uniquely) mapped reads. Most available NGS aligners attempt to address this by either removing all non-uniquely mapping reads, or reporting one random or "best" hit based on simple heuristics. Accurate estimation of the mapping quality of NGS reads is therefore critical albeit completely lacking at present. Here we developed a generalized software toolkit "AlignerBoost", which utilizes a Bayesian-based framework to accurately estimate mapping quality of ambiguously mapped NGS reads. We tested AlignerBoost with both simulated and real DNA-seq and RNA-seq datasets at various thresholds. In most cases, but especially for reads falling within repetitive regions, AlignerBoost dramatically increases the mapping precision of modern NGS aligners without significantly compromising the sensitivity even without mapping quality filters. When using higher mapping quality cutoffs, AlignerBoost achieves a much lower false mapping rate while exhibiting comparable or higher sensitivity compared to the aligner default modes, therefore significantly boosting the detection power of NGS aligners even using extreme thresholds. AlignerBoost is also SNP-aware, and higher quality alignments can be achieved if provided with known SNPs. AlignerBoost's algorithm is computationally efficient, and can process one million alignments within 30 seconds on a typical desktop computer. AlignerBoost is implemented as a uniform Java application and is freely available at https://github.com/Grice-Lab/AlignerBoost.

  20. PEAR: a fast and accurate Illumina Paired-End reAd mergeR.

    Science.gov (United States)

    Zhang, Jiajie; Kobert, Kassian; Flouri, Tomáš; Stamatakis, Alexandros

    2014-03-01

    The Illumina paired-end sequencing technology can generate reads from both ends of target DNA fragments, which can subsequently be merged to increase the overall read length. There already exist tools for merging these paired-end reads when the target fragments are equally long. However, when fragment lengths vary and, in particular, when either the fragment size is shorter than a single-end read, or longer than twice the size of a single-end read, most state-of-the-art mergers fail to generate reliable results. Therefore, a robust tool is needed to merge paired-end reads that exhibit varying overlap lengths because of varying target fragment lengths. We present the PEAR software for merging raw Illumina paired-end reads from target fragments of varying length. The program evaluates all possible paired-end read overlaps and does not require the target fragment size as input. It also implements a statistical test for minimizing false-positive results. Tests on simulated and empirical data show that PEAR consistently generates highly accurate merged paired-end reads. A highly optimized implementation allows for merging millions of paired-end reads within a few minutes on a standard desktop computer. On multi-core architectures, the parallel version of PEAR shows linear speedups compared with the sequential version of PEAR. PEAR is implemented in C and uses POSIX threads. It is freely available at http://www.exelixis-lab.org/web/software/pear.

  1. GateKeeper: a new hardware architecture for accelerating pre-alignment in DNA short read mapping.

    Science.gov (United States)

    Alser, Mohammed; Hassan, Hasan; Xin, Hongyi; Ergin, Oguz; Mutlu, Onur; Alkan, Can

    2017-11-01

    High throughput DNA sequencing (HTS) technologies generate an excessive number of small DNA segments -called short reads- that cause significant computational burden. To analyze the entire genome, each of the billions of short reads must be mapped to a reference genome based on the similarity between a read and 'candidate' locations in that reference genome. The similarity measurement, called alignment, formulated as an approximate string matching problem, is the computational bottleneck because: (i) it is implemented using quadratic-time dynamic programming algorithms and (ii) the majority of candidate locations in the reference genome do not align with a given read due to high dissimilarity. Calculating the alignment of such incorrect candidate locations consumes an overwhelming majority of a modern read mapper's execution time. Therefore, it is crucial to develop a fast and effective filter that can detect incorrect candidate locations and eliminate them before invoking computationally costly alignment algorithms. We propose GateKeeper, a new hardware accelerator that functions as a pre-alignment step that quickly filters out most incorrect candidate locations. GateKeeper is the first design to accelerate pre-alignment using Field-Programmable Gate Arrays (FPGAs), which can perform pre-alignment much faster than software. When implemented on a single FPGA chip, GateKeeper maintains high accuracy (on average >96%) while providing, on average, 90-fold and 130-fold speedup over the state-of-the-art software pre-alignment techniques, Adjacency Filter and Shifted Hamming Distance (SHD), respectively. The addition of GateKeeper as a pre-alignment step can reduce the verification time of the mrFAST mapper by a factor of 10. https://github.com/BilkentCompGen/GateKeeper. mohammedalser@bilkent.edu.tr or onur.mutlu@inf.ethz.ch or calkan@cs.bilkent.edu.tr. Supplementary data are available at Bioinformatics online. © The Author (2017). Published by Oxford University Press

  2. Coval: improving alignment quality and variant calling accuracy for next-generation sequencing data.

    Directory of Open Access Journals (Sweden)

    Shunichi Kosugi

    Full Text Available Accurate identification of DNA polymorphisms using next-generation sequencing technology is challenging because of a high rate of sequencing error and incorrect mapping of reads to reference genomes. Currently available short read aligners and DNA variant callers suffer from these problems. We developed the Coval software to improve the quality of short read alignments. Coval is designed to minimize the incidence of spurious alignment of short reads, by filtering mismatched reads that remained in alignments after local realignment and error correction of mismatched reads. The error correction is executed based on the base quality and allele frequency at the non-reference positions for an individual or pooled sample. We demonstrated the utility of Coval by applying it to simulated genomes and experimentally obtained short-read data of rice, nematode, and mouse. Moreover, we found an unexpectedly large number of incorrectly mapped reads in 'targeted' alignments, where the whole genome sequencing reads had been aligned to a local genomic segment, and showed that Coval effectively eliminated such spurious alignments. We conclude that Coval significantly improves the quality of short-read sequence alignments, thereby increasing the calling accuracy of currently available tools for SNP and indel identification. Coval is available at http://sourceforge.net/projects/coval105/.

  3. Accurate Local-Ancestry Inference in Exome-Sequenced Admixed Individuals via Off-Target Sequence Reads

    Science.gov (United States)

    Hu, Youna; Willer, Cristen; Zhan, Xiaowei; Kang, Hyun Min; Abecasis, Gonçalo R.

    2013-01-01

    Estimates of the ancestry of specific chromosomal regions in admixed individuals are useful for studies of human evolutionary history and for genetic association studies. Previously, this ancestry inference relied on high-quality genotypes from genome-wide association study (GWAS) arrays. These high-quality genotypes are not always available when samples are exome sequenced, and exome sequencing is the strategy of choice for many ongoing genetic studies. Here we show that off-target reads generated during exome-sequencing experiments can be combined with on-target reads to accurately estimate the ancestry of each chromosomal segment in an admixed individual. To reconstruct local ancestry, our method SEQMIX models aligned bases directly instead of relying on hard genotype calls. We evaluate the accuracy of our method through simulations and analysis of samples sequenced by the 1000 Genomes Project and the NHLBI Grand Opportunity Exome Sequencing Project. In African Americans, we show that local-ancestry estimates derived by our method are very similar to those derived with Illumina’s Omni 2.5M genotyping array and much improved in relation to estimates that use only exome genotypes and ignore off-target sequencing reads. Software implementing this method, SEQMIX, can be applied to analysis of human population history or used for genetic association studies in admixed individuals. PMID:24210252

  4. 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

  5. Hybrid De Novo Genome Assembly Using MiSeq and SOLiD Short Read Data.

    Directory of Open Access Journals (Sweden)

    Tsutomu Ikegami

    Full Text Available A hybrid de novo assembly pipeline was constructed to utilize both MiSeq and SOLiD short read data in combination in the assembly. The short read data were converted to a standard format of the pipeline, and were supplied to the pipeline components such as ABySS and SOAPdenovo. The assembly pipeline proceeded through several stages, and either MiSeq paired-end data, SOLiD mate-paired data, or both of them could be specified as input data at each stage separately. The pipeline was examined on the filamentous fungus Aspergillus oryzae RIB40, by aligning the assembly results against the reference sequences. Using both the MiSeq and the SOLiD data in the hybrid assembly, the alignment length was improved by a factor of 3 to 8, compared with the assemblies using either one of the data types. The number of the reproduced gene cluster regions encoding secondary metabolite biosyntheses (SMB was also improved by the hybrid assemblies. These results imply that the MiSeq data with long read length are essential to construct accurate nucleotide sequences, while the SOLiD mate-paired reads with long insertion length enhance long-range arrangements of the sequences. The pipeline was also tested on the actinomycete Streptomyces avermitilis MA-4680, whose gene is known to have high-GC content. Although the quality of the SOLiD reads was too low to perform any meaningful assemblies by themselves, the alignment length to the reference was improved by a factor of 2, compared with the assembly using only the MiSeq data.

  6. Rcorrector: efficient and accurate error correction for Illumina RNA-seq reads.

    Science.gov (United States)

    Song, Li; Florea, Liliana

    2015-01-01

    Next-generation sequencing of cellular RNA (RNA-seq) is rapidly becoming the cornerstone of transcriptomic analysis. However, sequencing errors in the already short RNA-seq reads complicate bioinformatics analyses, in particular alignment and assembly. Error correction methods have been highly effective for whole-genome sequencing (WGS) reads, but are unsuitable for RNA-seq reads, owing to the variation in gene expression levels and alternative splicing. We developed a k-mer based method, Rcorrector, to correct random sequencing errors in Illumina RNA-seq reads. Rcorrector uses a De Bruijn graph to compactly represent all trusted k-mers in the input reads. Unlike WGS read correctors, which use a global threshold to determine trusted k-mers, Rcorrector computes a local threshold at every position in a read. Rcorrector has an accuracy higher than or comparable to existing methods, including the only other method (SEECER) designed for RNA-seq reads, and is more time and memory efficient. With a 5 GB memory footprint for 100 million reads, it can be run on virtually any desktop or server. The software is available free of charge under the GNU General Public License from https://github.com/mourisl/Rcorrector/.

  7. Fast and simple protein-alignment-guided assembly of orthologous gene families from microbiome sequencing reads.

    Science.gov (United States)

    Huson, Daniel H; Tappu, Rewati; Bazinet, Adam L; Xie, Chao; Cummings, Michael P; Nieselt, Kay; Williams, Rohan

    2017-01-25

    Microbiome sequencing projects typically collect tens of millions of short reads per sample. Depending on the goals of the project, the short reads can either be subjected to direct sequence analysis or be assembled into longer contigs. The assembly of whole genomes from metagenomic sequencing reads is a very difficult problem. However, for some questions, only specific genes of interest need to be assembled. This is then a gene-centric assembly where the goal is to assemble reads into contigs for a family of orthologous genes. We present a new method for performing gene-centric assembly, called protein-alignment-guided assembly, and provide an implementation in our metagenome analysis tool MEGAN. Genes are assembled on the fly, based on the alignment of all reads against a protein reference database such as NCBI-nr. Specifically, the user selects a gene family based on a classification such as KEGG and all reads binned to that gene family are assembled. Using published synthetic community metagenome sequencing reads and a set of 41 gene families, we show that the performance of this approach compares favorably with that of full-featured assemblers and that of a recently published HMM-based gene-centric assembler, both in terms of the number of reference genes detected and of the percentage of reference sequence covered. Protein-alignment-guided assembly of orthologous gene families complements whole-metagenome assembly in a new and very useful way.

  8. 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

  9. 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

  10. Choice of reference sequence and assembler for alignment of Listeria monocytogenes short-read sequence data greatly influences rates of error in SNP analyses.

    Directory of Open Access Journals (Sweden)

    Arthur W Pightling

    Full Text Available The wide availability of whole-genome sequencing (WGS and an abundance of open-source software have made detection of single-nucleotide polymorphisms (SNPs in bacterial genomes an increasingly accessible and effective tool for comparative analyses. Thus, ensuring that real nucleotide differences between genomes (i.e., true SNPs are detected at high rates and that the influences of errors (such as false positive SNPs, ambiguously called sites, and gaps are mitigated is of utmost importance. The choices researchers make regarding the generation and analysis of WGS data can greatly influence the accuracy of short-read sequence alignments and, therefore, the efficacy of such experiments. We studied the effects of some of these choices, including: i depth of sequencing coverage, ii choice of reference-guided short-read sequence assembler, iii choice of reference genome, and iv whether to perform read-quality filtering and trimming, on our ability to detect true SNPs and on the frequencies of errors. We performed benchmarking experiments, during which we assembled simulated and real Listeria monocytogenes strain 08-5578 short-read sequence datasets of varying quality with four commonly used assemblers (BWA, MOSAIK, Novoalign, and SMALT, using reference genomes of varying genetic distances, and with or without read pre-processing (i.e., quality filtering and trimming. We found that assemblies of at least 50-fold coverage provided the most accurate results. In addition, MOSAIK yielded the fewest errors when reads were aligned to a nearly identical reference genome, while using SMALT to align reads against a reference sequence that is ∼0.82% distant from 08-5578 at the nucleotide level resulted in the detection of the greatest numbers of true SNPs and the fewest errors. Finally, we show that whether read pre-processing improves SNP detection depends upon the choice of reference sequence and assembler. In total, this study demonstrates that researchers

  11. Improved fingercode alignment for accurate and compact fingerprint recognition

    CSIR Research Space (South Africa)

    Brown, Dane

    2016-05-01

    Full Text Available Alignment for Accurate and Compact Fingerprint Recognition Dane Brown∗† and Karen Bradshaw∗ ∗Department of Computer Science Rhodes University Grahamstown, South Africa †Council for Scientific and Industrial Research Modelling and Digital Sciences Pretoria.... The experimental analysis and results are discussed in Section IV. Section V concludes the paper. II. RELATED STUDIES FingerCode [1] uses circular tessellation of filtered finger- print images centered at the reference point, which results in a circular ROI...

  12. 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.

  13. 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.

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

    NARCIS (Netherlands)

    Warris, S.; Yalcin, F.; Jackson, K.J.; Nap, J.P.H.

    2015-01-01

    Motivation 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

  15. 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.

  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. HeurAA: accurate and fast detection of genetic variations with a novel heuristic amplicon aligner program for next generation sequencing.

    Directory of Open Access Journals (Sweden)

    Lőrinc S Pongor

    Full Text Available Next generation sequencing (NGS of PCR amplicons is a standard approach to detect genetic variations in personalized medicine such as cancer diagnostics. Computer programs used in the NGS community often miss insertions and deletions (indels that constitute a large part of known human mutations. We have developed HeurAA, an open source, heuristic amplicon aligner program. We tested the program on simulated datasets as well as experimental data from multiplex sequencing of 40 amplicons in 12 oncogenes collected on a 454 Genome Sequencer from lung cancer cell lines. We found that HeurAA can accurately detect all indels, and is more than an order of magnitude faster than previous programs. HeurAA can compare reads and reference sequences up to several thousand base pairs in length, and it can evaluate data from complex mixtures containing reads of different gene-segments from different samples. HeurAA is written in C and Perl for Linux operating systems, the code and the documentation are available for research applications at http://sourceforge.net/projects/heuraa/

  18. Intraoperative panoramic image using alignment grid, is it accurate?

    Science.gov (United States)

    Apivatthakakul, T; Duanghakrung, M; Luevitoonvechkit, S; Patumasutra, S

    2013-07-01

    Minimally invasive orthopedic trauma surgery relies heavily on intraoperative fluoroscopic images to evaluate the quality of fracture reduction and fixation. However, fluoroscopic images have a narrow field of view and often cannot visualize the entire long bone axis. To compare the coronal femoral alignment between conventional X-rays to that achieved with a new method of acquiring a panoramic intraoperative image. Twenty-four cadaveric femurs with simple diaphyseal fractures were fixed with an angulated broad DCP to create coronal plane malalignment. An intraoperative alignment grid was used to help stitch different fluoroscopic images together to produce a panoramic image. A conventional X-ray of the entire femur was then performed. The coronal plane angulation in the panoramic images was then compared to the conventional X-rays using a Wilcoxon signed rank test. The mean angle measured from the panoramic view was 173.9° (range 169.3°-178.0°) with median of 173.2°. The mean angle measured from the conventional X-ray was 173.4° (range 167.7°-178.7°) with a median angle of 173.5°. There was no significant difference between both methods of measurement (P = 0.48). Panoramic images produced by stitching fluoroscopic images together with help of an alignment grid demonstrated the same accuracy at evaluating the coronal plane alignment of femur fractures as conventional X-rays.

  19. A practical strategy for the accurate measurement of residual dipolar couplings in strongly aligned small molecules

    Science.gov (United States)

    Liu, Yizhou; Cohen, Ryan D.; Martin, Gary E.; Williamson, R. Thomas

    2018-06-01

    Accurate measurement of residual dipolar couplings (RDCs) requires an appropriate degree of alignment in order to optimize data quality. An overly weak alignment yields very small anisotropic data that are susceptible to measurement errors, whereas an overly strong alignment introduces extensive anisotropic effects that severely degrade spectral quality. The ideal alignment amplitude also depends on the specific pulse sequence used for the coupling measurement. In this work, we introduce a practical strategy for the accurate measurement of one-bond 13C-1H RDCs up to a range of ca. -300 to +300 Hz, corresponding to an alignment that is an order of magnitude stronger than typically employed for small molecule structural elucidation. This strong alignment was generated in the mesophase of the commercially available poly-γ-(benzyl-L-glutamate) polymer. The total coupling was measured by the simple and well-studied heteronuclear two-dimensional J-resolved experiment, which performs well in the presence of strong anisotropic effects. In order to unequivocally determine the sign of the total coupling and resolve ambiguities in assigning total couplings in the CH2 group, coupling measurements were conducted at an isotropic condition plus two anisotropic conditions of different alignment amplitudes. Most RDCs could be readily extracted from these measurements whereas more complicated spectral effects resulting from strong homonuclear coupling could be interpreted either theoretically or by simulation. Importantly, measurement of these very large RDCs actually offers significantly improved data quality and utility for the structure determination of small organic molecules.

  20. Do Dual-Route Models Accurately Predict Reading and Spelling Performance in Individuals with Acquired Alexia and Agraphia?

    OpenAIRE

    Rapcsak, Steven Z.; Henry, Maya L.; Teague, Sommer L.; Carnahan, Susan D.; Beeson, Pélagie M.

    2007-01-01

    Coltheart and colleagues (Coltheart, Rastle, Perry, Langdon, & Ziegler, 2001; Castles, Bates, & Coltheart, 2006) have demonstrated that an equation derived from dual-route theory accurately predicts reading performance in young normal readers and in children with reading impairment due to developmental dyslexia or stroke. In this paper we present evidence that the dual-route equation and a related multiple regression model also accurately predict both reading and spelling performance in adult...

  1. Alignment of 1000 Genomes Project reads to reference assembly GRCh38.

    Science.gov (United States)

    Zheng-Bradley, Xiangqun; Streeter, Ian; Fairley, Susan; Richardson, David; Clarke, Laura; Flicek, Paul

    2017-07-01

    The 1000 Genomes Project produced more than 100 trillion basepairs of short read sequence from more than 2600 samples in 26 populations over a period of five years. In its final phase, the project released over 85 million genotyped and phased variants on human reference genome assembly GRCh37. An updated reference assembly, GRCh38, was released in late 2013, but there was insufficient time for the final phase of the project analysis to change to the new assembly. Although it is possible to lift the coordinates of the 1000 Genomes Project variants to the new assembly, this is a potentially error-prone process as coordinate remapping is most appropriate only for non-repetitive regions of the genome and those that did not see significant change between the two assemblies. It will also miss variants in any region that was newly added to GRCh38. Thus, to produce the highest quality variants and genotypes on GRCh38, the best strategy is to realign the reads and recall the variants based on the new alignment. As the first step of variant calling for the 1000 Genomes Project data, we have finished remapping all of the 1000 Genomes sequence reads to GRCh38 with alternative scaffold-aware BWA-MEM. The resulting alignments are available as CRAM, a reference-based sequence compression format. The data have been released on our FTP site and are also available from European Nucleotide Archive to facilitate researchers discovering variants on the primary sequences and alternative contigs of GRCh38. © The Authors 2017. Published by Oxford University Press.

  2. 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.

  3. Long-read sequencing data analysis for yeasts.

    Science.gov (United States)

    Yue, Jia-Xing; Liti, Gianni

    2018-06-01

    Long-read sequencing technologies have become increasingly popular due to their strengths in resolving complex genomic regions. As a leading model organism with small genome size and great biotechnological importance, the budding yeast Saccharomyces cerevisiae has many isolates currently being sequenced with long reads. However, analyzing long-read sequencing data to produce high-quality genome assembly and annotation remains challenging. Here, we present a modular computational framework named long-read sequencing data analysis for yeasts (LRSDAY), the first one-stop solution that streamlines this process. Starting from the raw sequencing reads, LRSDAY can produce chromosome-level genome assembly and comprehensive genome annotation in a highly automated manner with minimal manual intervention, which is not possible using any alternative tool available to date. The annotated genomic features include centromeres, protein-coding genes, tRNAs, transposable elements (TEs), and telomere-associated elements. Although tailored for S. cerevisiae, we designed LRSDAY to be highly modular and customizable, making it adaptable to virtually any eukaryotic organism. When applying LRSDAY to an S. cerevisiae strain, it takes ∼41 h to generate a complete and well-annotated genome from ∼100× Pacific Biosciences (PacBio) running the basic workflow with four threads. Basic experience working within the Linux command-line environment is recommended for carrying out the analysis using LRSDAY.

  4. Long-Term Outcomes of Early Reading Intervention

    Science.gov (United States)

    Hurry, Jane; Sylva, Kathy

    2007-01-01

    This study explores the long-term effectiveness of two differing models of early intervention for children with reading difficulties: Reading Recovery and a specific phonological training. Approximately 400 children were pre-tested, 95 were assigned to Reading Recovery, 97 to Phonological Training and the remainder acted as controls. In the short…

  5. 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

  6. Alignment-free Transcriptomic and Metatranscriptomic Comparison Using Sequencing Signatures with Variable Length Markov Chains.

    Science.gov (United States)

    Liao, Weinan; Ren, Jie; Wang, Kun; Wang, Shun; Zeng, Feng; Wang, Ying; Sun, Fengzhu

    2016-11-23

    The comparison between microbial sequencing data is critical to understand the dynamics of microbial communities. The alignment-based tools analyzing metagenomic datasets require reference sequences and read alignments. The available alignment-free dissimilarity approaches model the background sequences with Fixed Order Markov Chain (FOMC) yielding promising results for the comparison of microbial communities. However, in FOMC, the number of parameters grows exponentially with the increase of the order of Markov Chain (MC). Under a fixed high order of MC, the parameters might not be accurately estimated owing to the limitation of sequencing depth. In our study, we investigate an alternative to FOMC to model background sequences with the data-driven Variable Length Markov Chain (VLMC) in metatranscriptomic data. The VLMC originally designed for long sequences was extended to apply to high-throughput sequencing reads and the strategies to estimate the corresponding parameters were developed. The flexible number of parameters in VLMC avoids estimating the vast number of parameters of high-order MC under limited sequencing depth. Different from the manual selection in FOMC, VLMC determines the MC order adaptively. Several beta diversity measures based on VLMC were applied to compare the bacterial RNA-Seq and metatranscriptomic datasets. Experiments show that VLMC outperforms FOMC to model the background sequences in transcriptomic and metatranscriptomic samples. A software pipeline is available at https://d2vlmc.codeplex.com.

  7. Do dual-route models accurately predict reading and spelling performance in individuals with acquired alexia and agraphia?

    Science.gov (United States)

    Rapcsak, Steven Z; Henry, Maya L; Teague, Sommer L; Carnahan, Susan D; Beeson, Pélagie M

    2007-06-18

    Coltheart and co-workers [Castles, A., Bates, T. C., & Coltheart, M. (2006). John Marshall and the developmental dyslexias. Aphasiology, 20, 871-892; Coltheart, M., Rastle, K., Perry, C., Langdon, R., & Ziegler, J. (2001). DRC: A dual route cascaded model of visual word recognition and reading aloud. Psychological Review, 108, 204-256] have demonstrated that an equation derived from dual-route theory accurately predicts reading performance in young normal readers and in children with reading impairment due to developmental dyslexia or stroke. In this paper, we present evidence that the dual-route equation and a related multiple regression model also accurately predict both reading and spelling performance in adult neurological patients with acquired alexia and agraphia. These findings provide empirical support for dual-route theories of written language processing.

  8. DeepBound: accurate identification of transcript boundaries via deep convolutional neural fields

    KAUST Repository

    Shao, Mingfu; Ma, Jianzhu; Wang, Sheng

    2017-01-01

    Motivation: Reconstructing the full- length expressed transcripts (a. k. a. the transcript assembly problem) from the short sequencing reads produced by RNA-seq protocol plays a central role in identifying novel genes and transcripts as well as in studying gene expressions and gene functions. A crucial step in transcript assembly is to accurately determine the splicing junctions and boundaries of the expressed transcripts from the reads alignment. In contrast to the splicing junctions that can be efficiently detected from spliced reads, the problem of identifying boundaries remains open and challenging, due to the fact that the signal related to boundaries is noisy and weak.

  9. DeepBound: accurate identification of transcript boundaries via deep convolutional neural fields

    KAUST Repository

    Shao, Mingfu

    2017-04-20

    Motivation: Reconstructing the full- length expressed transcripts (a. k. a. the transcript assembly problem) from the short sequencing reads produced by RNA-seq protocol plays a central role in identifying novel genes and transcripts as well as in studying gene expressions and gene functions. A crucial step in transcript assembly is to accurately determine the splicing junctions and boundaries of the expressed transcripts from the reads alignment. In contrast to the splicing junctions that can be efficiently detected from spliced reads, the problem of identifying boundaries remains open and challenging, due to the fact that the signal related to boundaries is noisy and weak.

  10. Rapid detection, classification and accurate alignment of up to a million or more related protein sequences.

    Science.gov (United States)

    Neuwald, Andrew F

    2009-08-01

    The patterns of sequence similarity and divergence present within functionally diverse, evolutionarily related proteins contain implicit information about corresponding biochemical similarities and differences. A first step toward accessing such information is to statistically analyze these patterns, which, in turn, requires that one first identify and accurately align a very large set of protein sequences. Ideally, the set should include many distantly related, functionally divergent subgroups. Because it is extremely difficult, if not impossible for fully automated methods to align such sequences correctly, researchers often resort to manual curation based on detailed structural and biochemical information. However, multiply-aligning vast numbers of sequences in this way is clearly impractical. This problem is addressed using Multiply-Aligned Profiles for Global Alignment of Protein Sequences (MAPGAPS). The MAPGAPS program uses a set of multiply-aligned profiles both as a query to detect and classify related sequences and as a template to multiply-align the sequences. It relies on Karlin-Altschul statistics for sensitivity and on PSI-BLAST (and other) heuristics for speed. Using as input a carefully curated multiple-profile alignment for P-loop GTPases, MAPGAPS correctly aligned weakly conserved sequence motifs within 33 distantly related GTPases of known structure. By comparison, the sequence- and structurally based alignment methods hmmalign and PROMALS3D misaligned at least 11 and 23 of these regions, respectively. When applied to a dataset of 65 million protein sequences, MAPGAPS identified, classified and aligned (with comparable accuracy) nearly half a million putative P-loop GTPase sequences. A C++ implementation of MAPGAPS is available at http://mapgaps.igs.umaryland.edu. Supplementary data are available at Bioinformatics online.

  11. Fast and accurate non-sequential protein structure alignment using a new asymmetric linear sum assignment heuristic.

    Science.gov (United States)

    Brown, Peter; Pullan, Wayne; Yang, Yuedong; Zhou, Yaoqi

    2016-02-01

    The three dimensional tertiary structure of a protein at near atomic level resolution provides insight alluding to its function and evolution. As protein structure decides its functionality, similarity in structure usually implies similarity in function. As such, structure alignment techniques are often useful in the classifications of protein function. Given the rapidly growing rate of new, experimentally determined structures being made available from repositories such as the Protein Data Bank, fast and accurate computational structure comparison tools are required. This paper presents SPalignNS, a non-sequential protein structure alignment tool using a novel asymmetrical greedy search technique. The performance of SPalignNS was evaluated against existing sequential and non-sequential structure alignment methods by performing trials with commonly used datasets. These benchmark datasets used to gauge alignment accuracy include (i) 9538 pairwise alignments implied by the HOMSTRAD database of homologous proteins; (ii) a subset of 64 difficult alignments from set (i) that have low structure similarity; (iii) 199 pairwise alignments of proteins with similar structure but different topology; and (iv) a subset of 20 pairwise alignments from the RIPC set. SPalignNS is shown to achieve greater alignment accuracy (lower or comparable root-mean squared distance with increased structure overlap coverage) for all datasets, and the highest agreement with reference alignments from the challenging dataset (iv) above, when compared with both sequentially constrained alignments and other non-sequential alignments. SPalignNS was implemented in C++. The source code, binary executable, and a web server version is freely available at: http://sparks-lab.org yaoqi.zhou@griffith.edu.au. © The Author 2015. Published by Oxford University Press. All rights reserved. For Permissions, please e-mail: journals.permissions@oup.com.

  12. Intramedullary versus extramedullary alignment of the tibial component in the Triathlon knee

    LENUS (Irish Health Repository)

    Cashman, James P

    2011-08-20

    Abstract Background Long term survivorship in total knee arthroplasty is significantly dependant on prosthesis alignment. Our aim was determine which alignment guide was more accurate in positioning of the tibial component in total knee arthroplasty. We also aimed to assess whether there was any difference in short term patient outcome. Method A comparison of intramedullary versus extramedullary alignment jig was performed. Radiological alignment of tibial components and patient outcomes of 103 Triathlon total knee arthroplasties were analysed. Results Use of the intramedullary was found to be significantly more accurate in determining coronal alignment (p = 0.02) while use of the extramedullary jig was found to give more accurate results in sagittal alignment (p = 0.04). There was no significant difference in WOMAC or SF-36 at six months. Conclusion Use of an intramedullary jig is preferable for positioning of the tibial component using this knee system.

  13. Application of fast Fourier transform cross-correlation and mass spectrometry data for accurate alignment of chromatograms.

    Science.gov (United States)

    Zheng, Yi-Bao; Zhang, Zhi-Min; Liang, Yi-Zeng; Zhan, De-Jian; Huang, Jian-Hua; Yun, Yong-Huan; Xie, Hua-Lin

    2013-04-19

    Chromatography has been established as one of the most important analytical methods in the modern analytical laboratory. However, preprocessing of the chromatograms, especially peak alignment, is usually a time-consuming task prior to extracting useful information from the datasets because of the small unavoidable differences in the experimental conditions caused by minor changes and drift. Most of the alignment algorithms are performed on reduced datasets using only the detected peaks in the chromatograms, which means a loss of data and introduces the problem of extraction of peak data from the chromatographic profiles. These disadvantages can be overcome by using the full chromatographic information that is generated from hyphenated chromatographic instruments. A new alignment algorithm called CAMS (Chromatogram Alignment via Mass Spectra) is present here to correct the retention time shifts among chromatograms accurately and rapidly. In this report, peaks of each chromatogram were detected based on Continuous Wavelet Transform (CWT) with Haar wavelet and were aligned against the reference chromatogram via the correlation of mass spectra. The aligning procedure was accelerated by Fast Fourier Transform cross correlation (FFT cross correlation). This approach has been compared with several well-known alignment methods on real chromatographic datasets, which demonstrates that CAMS can preserve the shape of peaks and achieve a high quality alignment result. Furthermore, the CAMS method was implemented in the Matlab language and available as an open source package at http://www.github.com/matchcoder/CAMS. Copyright © 2013. Published by Elsevier B.V.

  14. Accurate marker-free alignment with simultaneous geometry determination and reconstruction of tilt series in electron tomography

    International Nuclear Information System (INIS)

    Winkler, Hanspeter; Taylor, Kenneth A.

    2006-01-01

    An image alignment method for electron tomography is presented which is based on cross-correlation techniques and which includes a simultaneous refinement of the tilt geometry. A coarsely aligned tilt series is iteratively refined with a procedure consisting of two steps for each cycle: area matching and subsequent geometry correction. The first step, area matching, brings into register equivalent specimen regions in all images of the tilt series. It determines four parameters of a linear two-dimensional transformation, not just translation and rotation as is done during the preceding coarse alignment with conventional methods. The refinement procedure also differs from earlier methods in that the alignment references are now computed from already aligned images by reprojection of a backprojected volume. The second step, geometry correction, refines the initially inaccurate estimates of the geometrical parameters, including the direction of the tilt axis, a tilt angle offset, and the inclination of the specimen with respect to the support film or specimen holder. The correction values serve as an indicator for the progress of the refinement. For each new iteration, the correction values are used to compute an updated set of geometry parameters by a least squares fit. Model calculations show that it is essential to refine the geometrical parameters as well as the accurate alignment of the images to obtain a faithful map of the original structure

  15. A Secure Alignment Algorithm for Mapping Short Reads to Human Genome.

    Science.gov (United States)

    Zhao, Yongan; Wang, Xiaofeng; Tang, Haixu

    2018-05-09

    The elastic and inexpensive computing resources such as clouds have been recognized as a useful solution to analyzing massive human genomic data (e.g., acquired by using next-generation sequencers) in biomedical researches. However, outsourcing human genome computation to public or commercial clouds was hindered due to privacy concerns: even a small number of human genome sequences contain sufficient information for identifying the donor of the genomic data. This issue cannot be directly addressed by existing security and cryptographic techniques (such as homomorphic encryption), because they are too heavyweight to carry out practical genome computation tasks on massive data. In this article, we present a secure algorithm to accomplish the read mapping, one of the most basic tasks in human genomic data analysis based on a hybrid cloud computing model. Comparing with the existing approaches, our algorithm delegates most computation to the public cloud, while only performing encryption and decryption on the private cloud, and thus makes the maximum use of the computing resource of the public cloud. Furthermore, our algorithm reports similar results as the nonsecure read mapping algorithms, including the alignment between reads and the reference genome, which can be directly used in the downstream analysis such as the inference of genomic variations. We implemented the algorithm in C++ and Python on a hybrid cloud system, in which the public cloud uses an Apache Spark system.

  16. A new automatic blood pressure kit auscultates for accurate reading with a smartphone

    Science.gov (United States)

    Wu, Hongjun; Wang, Bingjian; Zhu, Xinpu; Chu, Guang; Zhang, Zhi

    2016-01-01

    Abstract The widely used oscillometric automated blood pressure (BP) monitor was continuously questioned on its accuracy. A novel BP kit named Accutension which adopted Korotkoff auscultation method was then devised. Accutension worked with a miniature microphone, a pressure sensor, and a smartphone. The BP values were automatically displayed on the smartphone screen through the installed App. Data recorded in the phone could be played back and reconfirmed after measurement. They could also be uploaded and saved to the iCloud. The accuracy and consistency of this novel electronic auscultatory sphygmomanometer was preliminarily verified here. Thirty-two subjects were included and 82 qualified readings were obtained. The mean differences ± SD for systolic and diastolic BP readings between Accutension and mercury sphygmomanometer were 0.87 ± 2.86 and −0.94 ± 2.93 mm Hg. Agreements between Accutension and mercury sphygmomanometer were highly significant for systolic (ICC = 0.993, 95% confidence interval (CI): 0.989–0.995) and diastolic (ICC = 0.987, 95% CI: 0.979–0.991). In conclusion, Accutension worked accurately based on our pilot study data. The difference was acceptable. ICC and Bland–Altman plot charts showed good agreements with manual measurements. Systolic readings of Accutension were slightly higher than those of manual measurement, while diastolic readings were slightly lower. One possible reason was that Accutension captured the first and the last korotkoff sound more sensitively than human ear during manual measurement and avoided sound missing, so that it might be more accurate than traditional mercury sphygmomanometer. By documenting and analyzing of variant tendency of BP values, Accutension helps management of hypertension and therefore contributes to the mobile heath service. PMID:27512876

  17. SHARAKU: an algorithm for aligning and clustering read mapping profiles of deep sequencing in non-coding RNA processing.

    Science.gov (United States)

    Tsuchiya, Mariko; Amano, Kojiro; Abe, Masaya; Seki, Misato; Hase, Sumitaka; Sato, Kengo; Sakakibara, Yasubumi

    2016-06-15

    Deep sequencing of the transcripts of regulatory non-coding RNA generates footprints of post-transcriptional processes. After obtaining sequence reads, the short reads are mapped to a reference genome, and specific mapping patterns can be detected called read mapping profiles, which are distinct from random non-functional degradation patterns. These patterns reflect the maturation processes that lead to the production of shorter RNA sequences. Recent next-generation sequencing studies have revealed not only the typical maturation process of miRNAs but also the various processing mechanisms of small RNAs derived from tRNAs and snoRNAs. We developed an algorithm termed SHARAKU to align two read mapping profiles of next-generation sequencing outputs for non-coding RNAs. In contrast with previous work, SHARAKU incorporates the primary and secondary sequence structures into an alignment of read mapping profiles to allow for the detection of common processing patterns. Using a benchmark simulated dataset, SHARAKU exhibited superior performance to previous methods for correctly clustering the read mapping profiles with respect to 5'-end processing and 3'-end processing from degradation patterns and in detecting similar processing patterns in deriving the shorter RNAs. Further, using experimental data of small RNA sequencing for the common marmoset brain, SHARAKU succeeded in identifying the significant clusters of read mapping profiles for similar processing patterns of small derived RNA families expressed in the brain. The source code of our program SHARAKU is available at http://www.dna.bio.keio.ac.jp/sharaku/, and the simulated dataset used in this work is available at the same link. Accession code: The sequence data from the whole RNA transcripts in the hippocampus of the left brain used in this work is available from the DNA DataBank of Japan (DDBJ) Sequence Read Archive (DRA) under the accession number DRA004502. yasu@bio.keio.ac.jp Supplementary data are available

  18. Fast and accurate taxonomic assignments of metagenomic sequences using MetaBin.

    Directory of Open Access Journals (Sweden)

    Vineet K Sharma

    Full Text Available Taxonomic assignment of sequence reads is a challenging task in metagenomic data analysis, for which the present methods mainly use either composition- or homology-based approaches. Though the homology-based methods are more sensitive and accurate, they suffer primarily due to the time needed to generate the Blast alignments. We developed the MetaBin program and web server for better homology-based taxonomic assignments using an ORF-based approach. By implementing Blat as the faster alignment method in place of Blastx, the analysis time has been reduced by severalfold. It is benchmarked using both simulated and real metagenomic datasets, and can be used for both single and paired-end sequence reads of varying lengths (≥45 bp. To our knowledge, MetaBin is the only available program that can be used for the taxonomic binning of short reads (<100 bp with high accuracy and high sensitivity using a homology-based approach. The MetaBin web server can be used to carry out the taxonomic analysis, by either submitting reads or Blastx output. It provides several options including construction of taxonomic trees, creation of a composition chart, functional analysis using COGs, and comparative analysis of multiple metagenomic datasets. MetaBin web server and a standalone version for high-throughput analysis are available freely at http://metabin.riken.jp/.

  19. A new principle for the standardization of long paragraphs for reading speed analysis.

    Science.gov (United States)

    Radner, Wolfgang; Radner, Stephan; Diendorfer, Gabriela

    2016-01-01

    To investigate the reliability, validity, and statistical comparability of long paragraphs that were developed to be equivalent in construction and difficulty. Seven long paragraphs were developed that were equal in syntax, morphology, and number and position of words (111), with the same number of syllables (179) and number of characters (660). For validity analyses, the paragraphs were compared with the mean reading speed of a set of seven sentence optotypes of the RADNER Reading Charts (mean of 7 × 14 = 98 words read). Reliability analyses were performed by calculating the Cronbach's alpha value and the corrected total item correlation. Sixty participants (aged 20-77 years) read the paragraphs and the sentences (distance 40 cm; font: Times New Roman 12 pt). Test items were presented randomly; reading length was measured with a stopwatch. Reliability analysis yielded a Cronbach's alpha value of 0.988. When the long paragraphs were compared in pairwise fashion, significant differences were found in 13 of the 21 pairs (p differ significantly, and these paragraph combinations are therefore suitable for comparative research studies. The mean reading speed was 173.34 ± 24.01 words per minute (wpm) for the long paragraphs and 198.26 ± 28.60 wpm for the sentence optotypes. The maximum difference in reading speed was 5.55 % for the long paragraphs and 2.95 % for the short sentence optotypes. The correlation between long paragraphs and sentence optotypes was high (r = 0.9243). Despite good reliability and equivalence in construction and degree of difficulty, a statistically significant difference in reading speed can occur between long paragraphs. Since statistical significance should be dependent only on the persons tested, either standardizing long paragraphs for statistical equality of reading speed measurements or increasing the number of presented paragraphs is recommended for comparative investigations.

  20. The draft genome of MD-2 pineapple using hybrid error correction of long reads

    Science.gov (United States)

    Redwan, Raimi M.; Saidin, Akzam; Kumar, S. Vijay

    2016-01-01

    The introduction of the elite pineapple variety, MD-2, has caused a significant market shift in the pineapple industry. Better productivity, overall increased in fruit quality and taste, resilience to chilled storage and resistance to internal browning are among the key advantages of the MD-2 as compared with its previous predecessor, the Smooth Cayenne. Here, we present the genome sequence of the MD-2 pineapple (Ananas comosus (L.) Merr.) by using the hybrid sequencing technology from two highly reputable platforms, i.e. the PacBio long sequencing reads and the accurate Illumina short reads. Our draft genome achieved 99.6% genome coverage with 27,017 predicted protein-coding genes while 45.21% of the genome was identified as repetitive elements. Furthermore, differential expression of ripening RNASeq library of pineapple fruits revealed ethylene-related transcripts, believed to be involved in regulating the process of non-climacteric pineapple fruit ripening. The MD-2 pineapple draft genome serves as an example of how a complex heterozygous genome is amenable to whole genome sequencing by using a hybrid technology that is both economical and accurate. The genome will make genomic applications more feasible as a medium to understand complex biological processes specific to pineapple. PMID:27374615

  1. SCRAM: a pipeline for fast index-free small RNA read alignment and visualization.

    Science.gov (United States)

    Fletcher, Stephen J; Boden, Mikael; Mitter, Neena; Carroll, Bernard J

    2018-03-15

    Small RNAs play key roles in gene regulation, defense against viral pathogens and maintenance of genome stability, though many aspects of their biogenesis and function remain to be elucidated. SCRAM (Small Complementary RNA Mapper) is a novel, simple-to-use short read aligner and visualization suite that enhances exploration of small RNA datasets. The SCRAM pipeline is implemented in Go and Python, and is freely available under MIT license. Source code, multiplatform binaries and a Docker image can be accessed via https://sfletc.github.io/scram/. s.fletcher@uq.edu.au. Supplementary data are available at Bioinformatics online.

  2. 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

  3. Response to Intervention as a Predictor of Long-Term Reading Outcomes in Children with Dyslexia.

    Science.gov (United States)

    van der Kleij, Sanne W; Segers, Eliane; Groen, Margriet A; Verhoeven, Ludo

    2017-08-01

    The goal of this study was to investigate how growth during a phonics-based intervention, as well as reading levels at baseline testing, predicted long-term reading outcomes of children with dyslexia. Eighty Dutch children with dyslexia who had completed a 50-week phonics-based intervention in grade 4 were tested in grade 5 on both word and pseudoword (following regular Dutch orthographic patterns) reading efficiency and compared to 93 typical readers. In grade 5 the children with dyslexia were still significantly slower in word and pseudoword reading than their typically developing peers. Results showed that long-term pseudoword reading in the group with dyslexia was predicted by pseudoword reading at pretest and growth in pseudoword reading during the intervention, which was itself predicted by pseudoword reading at pretest. This was not the case for word reading. We found that long-term word reading was directly predicted from pretest word reading, and indirectly via pretest pseudoword reading, via growth in pseudoword and word reading. It can be concluded that pseudoword reading is not only a good indicator of severity of reading difficulties in children with dyslexia, it is also an indicator of who will profit from intervention in the long-term. Copyright © 2017 John Wiley & Sons, Ltd. Copyright © 2017 John Wiley & Sons, Ltd.

  4. Method for the mechanical axis alignment of the linear induction accelerator

    International Nuclear Information System (INIS)

    Li Hong; China Academy of Engineering Physics, Mianyang; Yao Jin; Liu Yunlong; Zhang Linwen; Deng Jianjun

    2004-01-01

    Accurate mechanical axis alignment is a basic requirement for assembling a linear induction accelerator (LIA). The total length of an LIA is usually over thirty or fifty meters, and it consists of many induction cells. By using a laser tracker a new method of mechanical axis alignment for LIA is established to achieve the high accuracy. This paper introduces the method and gives implementation step and point position measure errors of the mechanical axis alignment. During the alignment process a 55 m-long alignment control survey net is built, and the theoretic revision of the coordinate of the control survey net is presented. (authors)

  5. Research on localization and alignment technology for transfer cask

    Energy Technology Data Exchange (ETDEWEB)

    Wang, Jingchuan, E-mail: jchwang@sjtu.edu.cn [Department of Automation, Shanghai Jiao Tong University, Shanghai (China); Key Laboratory of System Control and Information Processing, Ministry of Education of China, Shanghai (China); Yang, Ming; Chen, Weidong [Department of Automation, Shanghai Jiao Tong University, Shanghai (China); Key Laboratory of System Control and Information Processing, Ministry of Education of China, Shanghai (China)

    2015-10-15

    Highlights: • A method for the alignment between TB and HCB based on localizability is proposed. • A localization method based on the localizability estimation is proposed to realize the cask's localization accurately and ensures the transfer cask's accurate docking in the front of the window of Tokmak Building. • The experimental results show that the proposed algorithm works well in the indoor simulation environment. This system will be test in EAST of China. - Abstract: According to the long length characteristics of transfer cask compared to the environment space between Tokmak Building (TB) and HCB (Hot Cell Building), this paper proposes an autonomous localization and alignment method for the internal components transportation and replacement. A localization method based on the localizability estimation is used to realize the cask's localization and navigation accurately. Once the cask arrives at the front of the TB window, the position and attitude measurement system is used to detect the relative alignment error between the seal door of pallet and the window of TB real-time. The alignment between seal door and TB window could be realized based on this offset. The simulation experiment based on the real model is designed according to the real TB situation. The experiment results show that the proposed localization and alignment method can be used for transfer cask.

  6. Towards accurate de novo assembly for genomes with repeats

    NARCIS (Netherlands)

    Bucur, Doina

    2017-01-01

    De novo genome assemblers designed for short k-mer length or using short raw reads are unlikely to recover complex features of the underlying genome, such as repeats hundreds of bases long. We implement a stochastic machine-learning method which obtains accurate assemblies with repeats and

  7. 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.

  8. Evaluation and Validation of Assembling Corrected PacBio Long Reads for Microbial Genome Completion via Hybrid Approaches.

    Science.gov (United States)

    Lin, Hsin-Hung; Liao, Yu-Chieh

    2015-01-01

    Despite the ever-increasing output of next-generation sequencing data along with developing assemblers, dozens to hundreds of gaps still exist in de novo microbial assemblies due to uneven coverage and large genomic repeats. Third-generation single-molecule, real-time (SMRT) sequencing technology avoids amplification artifacts and generates kilobase-long reads with the potential to complete microbial genome assembly. However, due to the low accuracy (~85%) of third-generation sequences, a considerable amount of long reads (>50X) are required for self-correction and for subsequent de novo assembly. Recently-developed hybrid approaches, using next-generation sequencing data and as few as 5X long reads, have been proposed to improve the completeness of microbial assembly. In this study we have evaluated the contemporary hybrid approaches and demonstrated that assembling corrected long reads (by runCA) produced the best assembly compared to long-read scaffolding (e.g., AHA, Cerulean and SSPACE-LongRead) and gap-filling (SPAdes). For generating corrected long reads, we further examined long-read correction tools, such as ECTools, LSC, LoRDEC, PBcR pipeline and proovread. We have demonstrated that three microbial genomes including Escherichia coli K12 MG1655, Meiothermus ruber DSM1279 and Pdeobacter heparinus DSM2366 were successfully hybrid assembled by runCA into near-perfect assemblies using ECTools-corrected long reads. In addition, we developed a tool, Patch, which implements corrected long reads and pre-assembled contigs as inputs, to enhance microbial genome assemblies. With the additional 20X long reads, short reads of S. cerevisiae W303 were hybrid assembled into 115 contigs using the verified strategy, ECTools + runCA. Patch was subsequently applied to upgrade the assembly to a 35-contig draft genome. Our evaluation of the hybrid approaches shows that assembling the ECTools-corrected long reads via runCA generates near complete microbial genomes, suggesting

  9. DB2: a probabilistic approach for accurate detection of tandem duplication breakpoints using paired-end reads.

    Science.gov (United States)

    Yavaş, Gökhan; Koyutürk, Mehmet; Gould, Meetha P; McMahon, Sarah; LaFramboise, Thomas

    2014-03-05

    With the advent of paired-end high throughput sequencing, it is now possible to identify various types of structural variation on a genome-wide scale. Although many methods have been proposed for structural variation detection, most do not provide precise boundaries for identified variants. In this paper, we propose a new method, Distribution Based detection of Duplication Boundaries (DB2), for accurate detection of tandem duplication breakpoints, an important class of structural variation, with high precision and recall. Our computational experiments on simulated data show that DB2 outperforms state-of-the-art methods in terms of finding breakpoints of tandem duplications, with a higher positive predictive value (precision) in calling the duplications' presence. In particular, DB2's prediction of tandem duplications is correct 99% of the time even for very noisy data, while narrowing down the space of possible breakpoints within a margin of 15 to 20 bps on the average. Most of the existing methods provide boundaries in ranges that extend to hundreds of bases with lower precision values. Our method is also highly robust to varying properties of the sequencing library and to the sizes of the tandem duplications, as shown by its stable precision, recall and mean boundary mismatch performance. We demonstrate our method's efficacy using both simulated paired-end reads, and those generated from a melanoma sample and two ovarian cancer samples. Newly discovered tandem duplications are validated using PCR and Sanger sequencing. Our method, DB2, uses discordantly aligned reads, taking into account the distribution of fragment length to predict tandem duplications along with their breakpoints on a donor genome. The proposed method fine tunes the breakpoint calls by applying a novel probabilistic framework that incorporates the empirical fragment length distribution to score each feasible breakpoint. DB2 is implemented in Java programming language and is freely available

  10. SINA: accurate high-throughput multiple sequence alignment of ribosomal RNA genes.

    Science.gov (United States)

    Pruesse, Elmar; Peplies, Jörg; Glöckner, Frank Oliver

    2012-07-15

    In the analysis of homologous sequences, computation of multiple sequence alignments (MSAs) has become a bottleneck. This is especially troublesome for marker genes like the ribosomal RNA (rRNA) where already millions of sequences are publicly available and individual studies can easily produce hundreds of thousands of new sequences. Methods have been developed to cope with such numbers, but further improvements are needed to meet accuracy requirements. In this study, we present the SILVA Incremental Aligner (SINA) used to align the rRNA gene databases provided by the SILVA ribosomal RNA project. SINA uses a combination of k-mer searching and partial order alignment (POA) to maintain very high alignment accuracy while satisfying high throughput performance demands. SINA was evaluated in comparison with the commonly used high throughput MSA programs PyNAST and mothur. The three BRAliBase III benchmark MSAs could be reproduced with 99.3, 97.6 and 96.1 accuracy. A larger benchmark MSA comprising 38 772 sequences could be reproduced with 98.9 and 99.3% accuracy using reference MSAs comprising 1000 and 5000 sequences. SINA was able to achieve higher accuracy than PyNAST and mothur in all performed benchmarks. Alignment of up to 500 sequences using the latest SILVA SSU/LSU Ref datasets as reference MSA is offered at http://www.arb-silva.de/aligner. This page also links to Linux binaries, user manual and tutorial. SINA is made available under a personal use license.

  11. Long-read sequencing and de novo assembly of a Chinese genome

    Science.gov (United States)

    Short-read sequencing has enabled the de novo assembly of several individual human genomes, but with inherent limitations in characterizing repeat elements. Here we sequence a Chinese individual HX1 by single-molecule real-time (SMRT) long-read sequencing, construct a physical map by NanoChannel arr...

  12. Desktop aligner for fabrication of multilayer microfluidic devices.

    Science.gov (United States)

    Li, Xiang; Yu, Zeta Tak For; Geraldo, Dalton; Weng, Shinuo; Alve, Nitesh; Dun, Wu; Kini, Akshay; Patel, Karan; Shu, Roberto; Zhang, Feng; Li, Gang; Jin, Qinghui; Fu, Jianping

    2015-07-01

    Multilayer assembly is a commonly used technique to construct multilayer polydimethylsiloxane (PDMS)-based microfluidic devices with complex 3D architecture and connectivity for large-scale microfluidic integration. Accurate alignment of structure features on different PDMS layers before their permanent bonding is critical in determining the yield and quality of assembled multilayer microfluidic devices. Herein, we report a custom-built desktop aligner capable of both local and global alignments of PDMS layers covering a broad size range. Two digital microscopes were incorporated into the aligner design to allow accurate global alignment of PDMS structures up to 4 in. in diameter. Both local and global alignment accuracies of the desktop aligner were determined to be about 20 μm cm(-1). To demonstrate its utility for fabrication of integrated multilayer PDMS microfluidic devices, we applied the desktop aligner to achieve accurate alignment of different functional PDMS layers in multilayer microfluidics including an organs-on-chips device as well as a microfluidic device integrated with vertical passages connecting channels located in different PDMS layers. Owing to its convenient operation, high accuracy, low cost, light weight, and portability, the desktop aligner is useful for microfluidic researchers to achieve rapid and accurate alignment for generating multilayer PDMS microfluidic devices.

  13. Indexed variation graphs for efficient and accurate resistome profiling.

    Science.gov (United States)

    Rowe, Will P M; Winn, Martyn D

    2018-05-14

    Antimicrobial resistance remains a major threat to global health. Profiling the collective antimicrobial resistance genes within a metagenome (the "resistome") facilitates greater understanding of antimicrobial resistance gene diversity and dynamics. In turn, this can allow for gene surveillance, individualised treatment of bacterial infections and more sustainable use of antimicrobials. However, resistome profiling can be complicated by high similarity between reference genes, as well as the sheer volume of sequencing data and the complexity of analysis workflows. We have developed an efficient and accurate method for resistome profiling that addresses these complications and improves upon currently available tools. Our method combines a variation graph representation of gene sets with an LSH Forest indexing scheme to allow for fast classification of metagenomic sequence reads using similarity-search queries. Subsequent hierarchical local alignment of classified reads against graph traversals enables accurate reconstruction of full-length gene sequences using a scoring scheme. We provide our implementation, GROOT, and show it to be both faster and more accurate than a current reference-dependent tool for resistome profiling. GROOT runs on a laptop and can process a typical 2 gigabyte metagenome in 2 minutes using a single CPU. Our method is not restricted to resistome profiling and has the potential to improve current metagenomic workflows. GROOT is written in Go and is available at https://github.com/will-rowe/groot (MIT license). will.rowe@stfc.ac.uk. Supplementary data are available at Bioinformatics online.

  14. A spectral algorithm for fast de novo layout of uncorrected long nanopore reads.

    Science.gov (United States)

    Recanati, Antoine; Brüls, Thomas; d'Aspremont, Alexandre

    2017-10-15

    New long read sequencers promise to transform sequencing and genome assembly by producing reads tens of kilobases long. However, their high error rate significantly complicates assembly and requires expensive correction steps to layout the reads using standard assembly engines. We present an original and efficient spectral algorithm to layout the uncorrected nanopore reads, and its seamless integration into a straightforward overlap/layout/consensus (OLC) assembly scheme. The method is shown to assemble Oxford Nanopore reads from several bacterial genomes into good quality (∼99% identity to the reference) genome-sized contigs, while yielding more fragmented assemblies from the eukaryotic microbe Sacharomyces cerevisiae. https://github.com/antrec/spectrassembler. antoine.recanati@inria.fr. Supplementary data are available at Bioinformatics online. © The Author (2017). Published by Oxford University Press. All rights reserved. For Permissions, please email: journals.permissions@oup.com

  15. Strawberry: Fast and accurate genome-guided transcript reconstruction and quantification from RNA-Seq.

    Science.gov (United States)

    Liu, Ruolin; Dickerson, Julie

    2017-11-01

    We propose a novel method and software tool, Strawberry, for transcript reconstruction and quantification from RNA-Seq data under the guidance of genome alignment and independent of gene annotation. Strawberry consists of two modules: assembly and quantification. The novelty of Strawberry is that the two modules use different optimization frameworks but utilize the same data graph structure, which allows a highly efficient, expandable and accurate algorithm for dealing large data. The assembly module parses aligned reads into splicing graphs, and uses network flow algorithms to select the most likely transcripts. The quantification module uses a latent class model to assign read counts from the nodes of splicing graphs to transcripts. Strawberry simultaneously estimates the transcript abundances and corrects for sequencing bias through an EM algorithm. Based on simulations, Strawberry outperforms Cufflinks and StringTie in terms of both assembly and quantification accuracies. Under the evaluation of a real data set, the estimated transcript expression by Strawberry has the highest correlation with Nanostring probe counts, an independent experiment measure for transcript expression. Strawberry is written in C++14, and is available as open source software at https://github.com/ruolin/strawberry under the MIT license.

  16. A statistically harmonized alignment-classification in image space enables accurate and robust alignment of noisy images in single particle analysis.

    Science.gov (United States)

    Kawata, Masaaki; Sato, Chikara

    2007-06-01

    In determining the three-dimensional (3D) structure of macromolecular assemblies in single particle analysis, a large representative dataset of two-dimensional (2D) average images from huge number of raw images is a key for high resolution. Because alignments prior to averaging are computationally intensive, currently available multireference alignment (MRA) software does not survey every possible alignment. This leads to misaligned images, creating blurred averages and reducing the quality of the final 3D reconstruction. We present a new method, in which multireference alignment is harmonized with classification (multireference multiple alignment: MRMA). This method enables a statistical comparison of multiple alignment peaks, reflecting the similarities between each raw image and a set of reference images. Among the selected alignment candidates for each raw image, misaligned images are statistically excluded, based on the principle that aligned raw images of similar projections have a dense distribution around the correctly aligned coordinates in image space. This newly developed method was examined for accuracy and speed using model image sets with various signal-to-noise ratios, and with electron microscope images of the Transient Receptor Potential C3 and the sodium channel. In every data set, the newly developed method outperformed conventional methods in robustness against noise and in speed, creating 2D average images of higher quality. This statistically harmonized alignment-classification combination should greatly improve the quality of single particle analysis.

  17. A comprehensive evaluation of alignment algorithms in the context of RNA-seq.

    Directory of Open Access Journals (Sweden)

    Robert Lindner

    Full Text Available Transcriptome sequencing (RNA-Seq overcomes limitations of previously used RNA quantification methods and provides one experimental framework for both high-throughput characterization and quantification of transcripts at the nucleotide level. The first step and a major challenge in the analysis of such experiments is the mapping of sequencing reads to a transcriptomic origin including the identification of splicing events. In recent years, a large number of such mapping algorithms have been developed, all of which have in common that they require algorithms for aligning a vast number of reads to genomic or transcriptomic sequences. Although the FM-index based aligner Bowtie has become a de facto standard within mapping pipelines, a much larger number of possible alignment algorithms have been developed also including other variants of FM-index based aligners. Accordingly, developers and users of RNA-seq mapping pipelines have the choice among a large number of available alignment algorithms. To provide guidance in the choice of alignment algorithms for these purposes, we evaluated the performance of 14 widely used alignment programs from three different algorithmic classes: algorithms using either hashing of the reference transcriptome, hashing of reads, or a compressed FM-index representation of the genome. Here, special emphasis was placed on both precision and recall and the performance for different read lengths and numbers of mismatches and indels in a read. Our results clearly showed the significant reduction in memory footprint and runtime provided by FM-index based aligners at a precision and recall comparable to the best hash table based aligners. Furthermore, the recently developed Bowtie 2 alignment algorithm shows a remarkable tolerance to both sequencing errors and indels, thus, essentially making hash-based aligners obsolete.

  18. Short read sequence typing (SRST: multi-locus sequence types from short reads

    Directory of Open Access Journals (Sweden)

    Inouye Michael

    2012-07-01

    Full Text Available Abstract Background Multi-locus sequence typing (MLST has become the gold standard for population analyses of bacterial pathogens. This method focuses on the sequences of a small number of loci (usually seven to divide the population and is simple, robust and facilitates comparison of results between laboratories and over time. Over the last decade, researchers and population health specialists have invested substantial effort in building up public MLST databases for nearly 100 different bacterial species, and these databases contain a wealth of important information linked to MLST sequence types such as time and place of isolation, host or niche, serotype and even clinical or drug resistance profiles. Recent advances in sequencing technology mean it is increasingly feasible to perform bacterial population analysis at the whole genome level. This offers massive gains in resolving power and genetic profiling compared to MLST, and will eventually replace MLST for bacterial typing and population analysis. However given the wealth of data currently available in MLST databases, it is crucial to maintain backwards compatibility with MLST schemes so that new genome analyses can be understood in their proper historical context. Results We present a software tool, SRST, for quick and accurate retrieval of sequence types from short read sets, using inputs easily downloaded from public databases. SRST uses read mapping and an allele assignment score incorporating sequence coverage and variability, to determine the most likely allele at each MLST locus. Analysis of over 3,500 loci in more than 500 publicly accessible Illumina read sets showed SRST to be highly accurate at allele assignment. SRST output is compatible with common analysis tools such as eBURST, Clonal Frame or PhyloViz, allowing easy comparison between novel genome data and MLST data. Alignment, fastq and pileup files can also be generated for novel alleles. Conclusions SRST is a novel

  19. 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...

  20. Towards Robust and Accurate Multi-View and Partially-Occluded Face Alignment.

    Science.gov (United States)

    Xing, Junliang; Niu, Zhiheng; Huang, Junshi; Hu, Weiming; Zhou, Xi; Yan, Shuicheng

    2018-04-01

    Face alignment acts as an important task in computer vision. Regression-based methods currently dominate the approach to solving this problem, which generally employ a series of mapping functions from the face appearance to iteratively update the face shape hypothesis. One keypoint here is thus how to perform the regression procedure. In this work, we formulate this regression procedure as a sparse coding problem. We learn two relational dictionaries, one for the face appearance and the other one for the face shape, with coupled reconstruction coefficient to capture their underlying relationships. To deploy this model for face alignment, we derive the relational dictionaries in a stage-wised manner to perform close-loop refinement of themselves, i.e., the face appearance dictionary is first learned from the face shape dictionary and then used to update the face shape hypothesis, and the updated face shape dictionary from the shape hypothesis is in return used to refine the face appearance dictionary. To improve the model accuracy, we extend this model hierarchically from the whole face shape to face part shapes, thus both the global and local view variations of a face are captured. To locate facial landmarks under occlusions, we further introduce an occlusion dictionary into the face appearance dictionary to recover face shape from partially occluded face appearance. The occlusion dictionary is learned in a data driven manner from background images to represent a set of elemental occlusion patterns, a sparse combination of which models various practical partial face occlusions. By integrating all these technical innovations, we obtain a robust and accurate approach to locate facial landmarks under different face views and possibly severe occlusions for face images in the wild. Extensive experimental analyses and evaluations on different benchmark datasets, as well as two new datasets built by ourselves, have demonstrated the robustness and accuracy of our proposed

  1. A new automatic blood pressure kit auscultates for accurate reading with a smartphone: A diagnostic accuracy study.

    Science.gov (United States)

    Wu, Hongjun; Wang, Bingjian; Zhu, Xinpu; Chu, Guang; Zhang, Zhi

    2016-08-01

    The widely used oscillometric automated blood pressure (BP) monitor was continuously questioned on its accuracy. A novel BP kit named Accutension which adopted Korotkoff auscultation method was then devised. Accutension worked with a miniature microphone, a pressure sensor, and a smartphone. The BP values were automatically displayed on the smartphone screen through the installed App. Data recorded in the phone could be played back and reconfirmed after measurement. They could also be uploaded and saved to the iCloud. The accuracy and consistency of this novel electronic auscultatory sphygmomanometer was preliminarily verified here. Thirty-two subjects were included and 82 qualified readings were obtained. The mean differences ± SD for systolic and diastolic BP readings between Accutension and mercury sphygmomanometer were 0.87 ± 2.86 and -0.94 ± 2.93 mm Hg. Agreements between Accutension and mercury sphygmomanometer were highly significant for systolic (ICC = 0.993, 95% confidence interval (CI): 0.989-0.995) and diastolic (ICC = 0.987, 95% CI: 0.979-0.991). In conclusion, Accutension worked accurately based on our pilot study data. The difference was acceptable. ICC and Bland-Altman plot charts showed good agreements with manual measurements. Systolic readings of Accutension were slightly higher than those of manual measurement, while diastolic readings were slightly lower. One possible reason was that Accutension captured the first and the last korotkoff sound more sensitively than human ear during manual measurement and avoided sound missing, so that it might be more accurate than traditional mercury sphygmomanometer. By documenting and analyzing of variant tendency of BP values, Accutension helps management of hypertension and therefore contributes to the mobile heath service.

  2. GapMis: a tool for pairwise sequence alignment with a single gap.

    Science.gov (United States)

    Flouri, Tomás; Frousios, Kimon; Iliopoulos, Costas S; Park, Kunsoo; Pissis, Solon P; Tischler, German

    2013-08-01

    Pairwise sequence alignment has received a new motivation due to the advent of recent patents in next-generation sequencing technologies, particularly so for the application of re-sequencing---the assembly of a genome directed by a reference sequence. After the fast alignment between a factor of the reference sequence and a high-quality fragment of a short read by a short-read alignment programme, an important problem is to find the alignment between a relatively short succeeding factor of the reference sequence and the remaining low-quality part of the read allowing a number of mismatches and the insertion of a single gap in the alignment. We present GapMis, a tool for pairwise sequence alignment with a single gap. It is based on a simple algorithm, which computes a different version of the traditional dynamic programming matrix. The presented experimental results demonstrate that GapMis is more suitable and efficient than most popular tools for this task.

  3. What oral text reading fluency can reveal about reading comprehension

    NARCIS (Netherlands)

    Veenendaal, N.J.; Groen, M.A.; Verhoeven, L.T.W.

    2015-01-01

    Text reading fluency – the ability to read quickly, accurately and with a natural intonation – has been proposed as a predictor of reading comprehension. In the current study, we examined the role of oral text reading fluency, defined as text reading rate and text reading prosody, as a contributor

  4. COCACOLA: binning metagenomic contigs using sequence COmposition, read CoverAge, CO-alignment and paired-end read LinkAge.

    Science.gov (United States)

    Lu, Yang Young; Chen, Ting; Fuhrman, Jed A; Sun, Fengzhu

    2017-03-15

    The advent of next-generation sequencing technologies enables researchers to sequence complex microbial communities directly from the environment. Because assembly typically produces only genome fragments, also known as contigs, instead of an entire genome, it is crucial to group them into operational taxonomic units (OTUs) for further taxonomic profiling and down-streaming functional analysis. OTU clustering is also referred to as binning. We present COCACOLA, a general framework automatically bin contigs into OTUs based on sequence composition and coverage across multiple samples. The effectiveness of COCACOLA is demonstrated in both simulated and real datasets in comparison with state-of-art binning approaches such as CONCOCT, GroopM, MaxBin and MetaBAT. The superior performance of COCACOLA relies on two aspects. One is using L 1 distance instead of Euclidean distance for better taxonomic identification during initialization. More importantly, COCACOLA takes advantage of both hard clustering and soft clustering by sparsity regularization. In addition, the COCACOLA framework seamlessly embraces customized knowledge to facilitate binning accuracy. In our study, we have investigated two types of additional knowledge, the co-alignment to reference genomes and linkage of contigs provided by paired-end reads, as well as the ensemble of both. We find that both co-alignment and linkage information further improve binning in the majority of cases. COCACOLA is scalable and faster than CONCOCT, GroopM, MaxBin and MetaBAT. The software is available at https://github.com/younglululu/COCACOLA . fsun@usc.edu. 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. Using structure to explore the sequence alignment space of remote homologs.

    Science.gov (United States)

    Kuziemko, Andrew; Honig, Barry; Petrey, Donald

    2011-10-01

    Protein structure modeling by homology requires an accurate sequence alignment between the query protein and its structural template. However, sequence alignment methods based on dynamic programming (DP) are typically unable to generate accurate alignments for remote sequence homologs, thus limiting the applicability of modeling methods. A central problem is that the alignment that is "optimal" in terms of the DP score does not necessarily correspond to the alignment that produces the most accurate structural model. That is, the correct alignment based on structural superposition will generally have a lower score than the optimal alignment obtained from sequence. Variations of the DP algorithm have been developed that generate alternative alignments that are "suboptimal" in terms of the DP score, but these still encounter difficulties in detecting the correct structural alignment. We present here a new alternative sequence alignment method that relies heavily on the structure of the template. By initially aligning the query sequence to individual fragments in secondary structure elements and combining high-scoring fragments that pass basic tests for "modelability", we can generate accurate alignments within a small ensemble. Our results suggest that the set of sequences that can currently be modeled by homology can be greatly extended.

  6. ScanIndel: a hybrid framework for indel detection via gapped alignment, split reads and de novo assembly.

    Science.gov (United States)

    Yang, Rendong; Nelson, Andrew C; Henzler, Christine; Thyagarajan, Bharat; Silverstein, Kevin A T

    2015-12-07

    Comprehensive identification of insertions/deletions (indels) across the full size spectrum from second generation sequencing is challenging due to the relatively short read length inherent in the technology. Different indel calling methods exist but are limited in detection to specific sizes with varying accuracy and resolution. We present ScanIndel, an integrated framework for detecting indels with multiple heuristics including gapped alignment, split reads and de novo assembly. Using simulation data, we demonstrate ScanIndel's superior sensitivity and specificity relative to several state-of-the-art indel callers across various coverage levels and indel sizes. ScanIndel yields higher predictive accuracy with lower computational cost compared with existing tools for both targeted resequencing data from tumor specimens and high coverage whole-genome sequencing data from the human NIST standard NA12878. Thus, we anticipate ScanIndel will improve indel analysis in both clinical and research settings. ScanIndel is implemented in Python, and is freely available for academic use at https://github.com/cauyrd/ScanIndel.

  7. Accurate overlaying for mobile augmented reality

    NARCIS (Netherlands)

    Pasman, W; van der Schaaf, A; Lagendijk, RL; Jansen, F.W.

    1999-01-01

    Mobile augmented reality requires accurate alignment of virtual information with objects visible in the real world. We describe a system for mobile communications to be developed to meet these strict alignment criteria using a combination of computer vision. inertial tracking and low-latency

  8. Can a semi-automated surface matching and principal axis-based algorithm accurately quantify femoral shaft fracture alignment in six degrees of freedom?

    Science.gov (United States)

    Crookshank, Meghan C; Beek, Maarten; Singh, Devin; Schemitsch, Emil H; Whyne, Cari M

    2013-07-01

    Accurate alignment of femoral shaft fractures treated with intramedullary nailing remains a challenge for orthopaedic surgeons. The aim of this study is to develop and validate a cone-beam CT-based, semi-automated algorithm to quantify the malalignment in six degrees of freedom (6DOF) using a surface matching and principal axes-based approach. Complex comminuted diaphyseal fractures were created in nine cadaveric femora and cone-beam CT images were acquired (27 cases total). Scans were cropped and segmented using intensity-based thresholding, producing superior, inferior and comminution volumes. Cylinders were fit to estimate the long axes of the superior and inferior fragments. The angle and distance between the two cylindrical axes were calculated to determine flexion/extension and varus/valgus angulation and medial/lateral and anterior/posterior translations, respectively. Both surfaces were unwrapped about the cylindrical axes. Three methods of matching the unwrapped surface for determination of periaxial rotation were compared based on minimizing the distance between features. The calculated corrections were compared to the input malalignment conditions. All 6DOF were calculated to within current clinical tolerances for all but two cases. This algorithm yielded accurate quantification of malalignment of femoral shaft fractures for fracture gaps up to 60 mm, based on a single CBCT image of the fractured limb. Copyright © 2012 IPEM. Published by Elsevier Ltd. All rights reserved.

  9. Extraction of High Molecular Weight DNA from Fungal Rust Spores for Long Read Sequencing.

    Science.gov (United States)

    Schwessinger, Benjamin; Rathjen, John P

    2017-01-01

    Wheat rust fungi are complex organisms with a complete life cycle that involves two different host plants and five different spore types. During the asexual infection cycle on wheat, rusts produce massive amounts of dikaryotic urediniospores. These spores are dikaryotic (two nuclei) with each nucleus containing one haploid genome. This dikaryotic state is likely to contribute to their evolutionary success, making them some of the major wheat pathogens globally. Despite this, most published wheat rust genomes are highly fragmented and contain very little haplotype-specific sequence information. Current long-read sequencing technologies hold great promise to provide more contiguous and haplotype-phased genome assemblies. Long reads are able to span repetitive regions and phase structural differences between the haplomes. This increased genome resolution enables the identification of complex loci and the study of genome evolution beyond simple nucleotide polymorphisms. Long-read technologies require pure high molecular weight DNA as an input for sequencing. Here, we describe a DNA extraction protocol for rust spores that yields pure double-stranded DNA molecules with molecular weight of >50 kilo-base pairs (kbp). The isolated DNA is of sufficient purity for PacBio long-read sequencing, but may require additional purification for other sequencing technologies such as Nanopore and 10× Genomics.

  10. Using structure to explore the sequence alignment space of remote homologs.

    Directory of Open Access Journals (Sweden)

    Andrew Kuziemko

    2011-10-01

    Full Text Available Protein structure modeling by homology requires an accurate sequence alignment between the query protein and its structural template. However, sequence alignment methods based on dynamic programming (DP are typically unable to generate accurate alignments for remote sequence homologs, thus limiting the applicability of modeling methods. A central problem is that the alignment that is "optimal" in terms of the DP score does not necessarily correspond to the alignment that produces the most accurate structural model. That is, the correct alignment based on structural superposition will generally have a lower score than the optimal alignment obtained from sequence. Variations of the DP algorithm have been developed that generate alternative alignments that are "suboptimal" in terms of the DP score, but these still encounter difficulties in detecting the correct structural alignment. We present here a new alternative sequence alignment method that relies heavily on the structure of the template. By initially aligning the query sequence to individual fragments in secondary structure elements and combining high-scoring fragments that pass basic tests for "modelability", we can generate accurate alignments within a small ensemble. Our results suggest that the set of sequences that can currently be modeled by homology can be greatly extended.

  11. Construction process and read-out electronics of amorphous silicon position detectors for multipoint alignment monitoring

    Energy Technology Data Exchange (ETDEWEB)

    Koehler, C.; Schubert, M.B.; Lutz, B.; Werner, J.H. [Steinbeis-Transferzentrum fuer Angewandte Photovoltaik und Duennschichttechnik, Stuttgart (Germany); Alberdi, J.; Arce, P.; Barcala, J.M.; Calvo, E. [CIEMAT, Madrid (Spain); Ferrando, A. [CIEMAT, Madrid (Spain)], E-mail: antonio.ferrando@ciemat.es; Josa, M.I.; Molinero, A.; Navarrete, J.; Oller, J.C.; Yuste, C. [CIEMAT, Madrid (Spain); Calderon, A.; Fernandez, M.G.; Gomez, G.; Gonzalez-Sanchez, F.J.; Martinez-Rivero, C.; Matorras, F. [Instituto de Fisica de Cantabria IFCA/CSIC-University of Cantabria, Santander (Spain)] (and others)

    2009-09-01

    We describe the construction process of large-area high-performance transparent amorphous silicon position detecting sensors. Details about the characteristics of the associated local electronic board (LEB), specially designed for these sensors, are given. In addition we report on the performance of a multipoint alignment monitoring application of 12 sensors in a 13 m long light path.

  12. Choosing Great Books for Babies: Helping Children Develop a Life-Long Love of Reading

    Science.gov (United States)

    Honig, Alice Sterling

    2007-01-01

    This article describes how a great choice of books could help children develop a life-long love of reading. Every teacher wants to boost a baby's chances in later success. The single most powerful tool a teacher has for awakening a deep love of books and learning is to read to children daily. Reading should become a loved, intimate activity filled…

  13. Computational complexity of algorithms for sequence comparison, short-read assembly and genome alignment.

    Science.gov (United States)

    Baichoo, Shakuntala; Ouzounis, Christos A

    A multitude of algorithms for sequence comparison, short-read assembly and whole-genome alignment have been developed in the general context of molecular biology, to support technology development for high-throughput sequencing, numerous applications in genome biology and fundamental research on comparative genomics. The computational complexity of these algorithms has been previously reported in original research papers, yet this often neglected property has not been reviewed previously in a systematic manner and for a wider audience. We provide a review of space and time complexity of key sequence analysis algorithms and highlight their properties in a comprehensive manner, in order to identify potential opportunities for further research in algorithm or data structure optimization. The complexity aspect is poised to become pivotal as we will be facing challenges related to the continuous increase of genomic data on unprecedented scales and complexity in the foreseeable future, when robust biological simulation at the cell level and above becomes a reality. Copyright © 2017 Elsevier B.V. All rights reserved.

  14. Alignment and qualification of the Gaia telescope using a Shack-Hartmann sensor

    Science.gov (United States)

    Dovillaire, G.; Pierot, D.

    2017-09-01

    Since almost 20 years, Imagine Optic develops, manufactures and offers to its worldwide customers reliable and accurate wavefront sensors and adaptive optics solutions. Long term collaboration between Imagine Optic and Airbus Defence and Space has been initiated on the Herschel program. More recently, a similar technology has been used to align and qualify the GAIA telescope.

  15. Long-Term Experience with Chinese Language Shapes the Fusiform Asymmetry of English Reading

    Science.gov (United States)

    Mei, Leilei; Xue, Gui; Lu, Zhong-Lin; Chen, Chuansheng; Wei, Miao; He, Qinghua; Dong, Qi

    2015-01-01

    Previous studies have suggested differential engagement of the bilateral fusiform gyrus in the processing of Chinese and English. The present study tested the possibility that long-term experience with Chinese language affects the fusiform laterality of English reading by comparing three samples: Chinese speakers, English speakers with Chinese experience, and English speakers without Chinese experience. We found that, when reading words in their respective native language, Chinese and English speakers without Chinese experience differed in functional laterality of the posterior fusiform region (right laterality for Chinese speakers, but left laterality for English speakers). More importantly, compared with English speakers without Chinese experience, English speakers with Chinese experience showed more recruitment of the right posterior fusiform cortex for English words and pseudowords, which is similar to how Chinese speakers processed Chinese. These results suggest that long-term experience with Chinese shapes the fusiform laterality of English reading and have important implications for our understanding of the cross-language influences in terms of neural organization and of the functions of different fusiform subregions in reading. PMID:25598049

  16. Detecting the limits of regulatory element conservation anddivergence estimation using pairwise and multiple alignments

    Energy Technology Data Exchange (ETDEWEB)

    Pollard, Daniel A.; Moses, Alan M.; Iyer, Venky N.; Eisen,Michael B.

    2006-08-14

    Background: Molecular evolutionary studies of noncodingsequences rely on multiple alignments. Yet how multiple alignmentaccuracy varies across sequence types, tree topologies, divergences andtools, and further how this variation impacts specific inferences,remains unclear. Results: Here we develop a molecular evolutionsimulation platform, CisEvolver, with models of background noncoding andtranscription factor binding site evolution, and use simulated alignmentsto systematically examine multiple alignment accuracy and its impact ontwo key molecular evolutionary inferences: transcription factor bindingsite conservation and divergence estimation. We find that the accuracy ofmultiple alignments is determined almost exclusively by the pairwisedivergence distance of the two most diverged species and that additionalspecies have a negligible influence on alignment accuracy. Conservedtranscription factor binding sites align better than surroundingnoncoding DNA yet are often found to be misaligned at relatively shortdivergence distances, such that studies of binding site gain and losscould easily be confounded by alignment error. Divergence estimates frommultiple alignments tend to be overestimated at short divergencedistances but reach a tool specific divergence at which they cease toincrease, leading to underestimation at long divergences. Our moststriking finding was that overall alignment accuracy, binding sitealignment accuracy and divergence estimation accuracy vary greatly acrossbranches in a tree and are most accurate for terminal branches connectingsister taxa and least accurate for internal branches connectingsub-alignments. Conclusions: Our results suggest that variation inalignment accuracy can lead to errors in molecular evolutionaryinferences that could be construed as biological variation. Thesefindings have implications for which species to choose for analyses, whatkind of errors would be expected for a given set of species and howmultiple alignment tools and

  17. Radiologic analysis of hindfoot alignment: Comparison of Méary, long axial, and hindfoot alignment views.

    Science.gov (United States)

    Neri, T; Barthelemy, R; Tourné, Y

    2017-12-01

    Among radiographic views available for assessing hindfoot alignment, the antero-posterior weight-bearing view with metal cerclage of the hindfoot (Méary view) is the most widely used in France. Internationally, the long axial view (LAV) and hindfoot alignment view (HAV) are used also. The objective of this study was to compare the reliability of these three views. The Méary view with cerclage of the hindfoot is as reliable as the LAV and HAV for assessing hindfoot alignment. All three views were obtained in each of 22 prospectively included patients. Intra-observer and inter-observer reliabilities were assessed by having two observers collect the radiographic measurements then computing the intra-class correlation coefficients (ICCs). The intra-observer and inter-observer ICCs were 0.956 and 0.988 with the Méary view, 0.990 and 0.765 with the HAV, and 0.997 and 0.991 with the LAV, respectively. Correlations were far stronger between the LAV and HAV than between each of these and the Méary view. Compared to the LAV and HAV, the Méary view indicated a greater degree of hindfoot valgus. Intra-observer reliability was excellent with both the LAV and HAV, whereas inter-observer reliability was better with the LAV. Excellent reliability was also obtained with the Méary view. Combining the Méary view to obtain a radiographic image of the clinical deformity with the LAV to measure the angular deviation of the hindfoot axis may be useful when assessing hindfoot malalignment. A comparison of the three views in a larger population is needed before clinical recommendations can be made. II, prospective study. Copyright © 2017 Elsevier Masson SAS. All rights reserved.

  18. An automatic and accurate x-ray tube focal spot/grid alignment system for mobile radiography: System description and alignment accuracy

    International Nuclear Information System (INIS)

    Gauntt, David M.; Barnes, Gary T.

    2010-01-01

    Purpose: A mobile radiography automatic grid alignment system (AGAS) has been developed by modifying a commercially available mobile unit. The objectives of this article are to describe the modifications and operation and to report on the accuracy with which the focal spot is aligned to the grid and the time required to achieve the alignment. Methods: The modifications include an optical target arm attached to the grid tunnel, a video camera attached to the collimator, a motion control system with six degrees of freedom to position the collimator and x-ray tube, and a computer to control the system. The video camera and computer determine the grid position, and then the motion control system drives the x-ray focal spot to the center of the grid focal axis. The accuracy of the alignment of the focal spot with the grid and the time required to achieve alignment were measured both in laboratory tests and in clinical use. Results: For a typical exam, the modified unit automatically aligns the focal spot with the grid in less than 10 s, with an accuracy of better than 4 mm. The results of the speed and accuracy tests in clinical use were similar to the results in laboratory tests. Comparison patient chest images are presented--one obtained with a standard mobile radiographic unit without a grid and the other obtained with the modified unit and a 15:1 grid. The 15:1 grid images demonstrate a marked improvement in image quality compared to the nongrid images with no increase in patient dose. Conclusions: The mobile radiography AGAS produces images of significantly improved quality compared to nongrid images with alignment times of less than 10 s and no increase in patient dose.

  19. Constrained-DFT method for accurate energy-level alignment of metal/molecule interfaces

    KAUST Repository

    Souza, A. M.

    2013-10-07

    We present a computational scheme for extracting the energy-level alignment of a metal/molecule interface, based on constrained density functional theory and local exchange and correlation functionals. The method, applied here to benzene on Li(100), allows us to evaluate charge-transfer energies, as well as the spatial distribution of the image charge induced on the metal surface. We systematically study the energies for charge transfer from the molecule to the substrate as function of the molecule-substrate distance, and investigate the effects arising from image-charge confinement and local charge neutrality violation. For benzene on Li(100) we find that the image-charge plane is located at about 1.8 Å above the Li surface, and that our calculated charge-transfer energies compare perfectly with those obtained with a classical electrostatic model having the image plane located at the same position. The methodology outlined here can be applied to study any metal/organic interface in the weak coupling limit at the computational cost of a total energy calculation. Most importantly, as the scheme is based on total energies and not on correcting the Kohn-Sham quasiparticle spectrum, accurate results can be obtained with local/semilocal exchange and correlation functionals. This enables a systematic approach to convergence.

  20. Constrained-DFT method for accurate energy-level alignment of metal/molecule interfaces

    KAUST Repository

    Souza, A. M.; Rungger, I.; Pemmaraju, C. D.; Schwingenschlö gl, Udo; Sanvito, S.

    2013-01-01

    We present a computational scheme for extracting the energy-level alignment of a metal/molecule interface, based on constrained density functional theory and local exchange and correlation functionals. The method, applied here to benzene on Li(100), allows us to evaluate charge-transfer energies, as well as the spatial distribution of the image charge induced on the metal surface. We systematically study the energies for charge transfer from the molecule to the substrate as function of the molecule-substrate distance, and investigate the effects arising from image-charge confinement and local charge neutrality violation. For benzene on Li(100) we find that the image-charge plane is located at about 1.8 Å above the Li surface, and that our calculated charge-transfer energies compare perfectly with those obtained with a classical electrostatic model having the image plane located at the same position. The methodology outlined here can be applied to study any metal/organic interface in the weak coupling limit at the computational cost of a total energy calculation. Most importantly, as the scheme is based on total energies and not on correcting the Kohn-Sham quasiparticle spectrum, accurate results can be obtained with local/semilocal exchange and correlation functionals. This enables a systematic approach to convergence.

  1. GOSSIP: a method for fast and accurate global alignment of protein structures.

    Science.gov (United States)

    Kifer, I; Nussinov, R; Wolfson, H J

    2011-04-01

    The database of known protein structures (PDB) is increasing rapidly. This results in a growing need for methods that can cope with the vast amount of structural data. To analyze the accumulating data, it is important to have a fast tool for identifying similar structures and clustering them by structural resemblance. Several excellent tools have been developed for the comparison of protein structures. These usually address the task of local structure alignment, an important yet computationally intensive problem due to its complexity. It is difficult to use such tools for comparing a large number of structures to each other at a reasonable time. Here we present GOSSIP, a novel method for a global all-against-all alignment of any set of protein structures. The method detects similarities between structures down to a certain cutoff (a parameter of the program), hence allowing it to detect similar structures at a much higher speed than local structure alignment methods. GOSSIP compares many structures in times which are several orders of magnitude faster than well-known available structure alignment servers, and it is also faster than a database scanning method. We evaluate GOSSIP both on a dataset of short structural fragments and on two large sequence-diverse structural benchmarks. Our conclusions are that for a threshold of 0.6 and above, the speed of GOSSIP is obtained with no compromise of the accuracy of the alignments or of the number of detected global similarities. A server, as well as an executable for download, are available at http://bioinfo3d.cs.tau.ac.il/gossip/.

  2. Assessing Lower Limb Alignment: Comparison of Standard Knee Xray vs Long Leg View.

    Science.gov (United States)

    Zampogna, Biagio; Vasta, Sebastiano; Amendola, Annunziato; Uribe-Echevarria Marbach, Bastian; Gao, Yubo; Papalia, Rocco; Denaro, Vincenzo

    2015-01-01

    High tibial osteotomy (HTO) is a well-established and commonly utilized technique in medial knee osteoarthritis secondary to varus malalignment. Accurate measurement of the preoperative limb alignment, and the amount of correction required are essential when planning limb realignment surgery. The hip-knee-ankle angle (HKA) measured on a full length weightbearing (FLWB) X-ray in the standing position is considered the gold standard, since it allows for reliable and accurate measurement of the mechanical axis of the whole lower extremity. In general practice, alignment is often evaluated on standard anteroposterior weightbearing (APWB) X-rays, as the angle between the femur and tibial anatomic axis (TFa). It is, therefore, of value to establish if measuring the anatomical axis from limited APWB is an effective measure of knee alignment especially in patients undergoing osteotomy about the knee. Three independent observers measured preoperative and postoperative FTa with standard method (FTa1) and with circles method (FTa2) on APWB X-ray and the HKA on FLWB X-ray at three different time-points separated by a two-week period. Intra-observer and inter-observer reliabilities and the comparison and relationship between anatomical and mechanical alignment were calculated. Intra- and interclass coefficients for all the three methods indicated excellent reliability, having all the values above 0.80. Using the mean of paired t-student test, the comparison of HKA versus TFa1 and TFa2 showed a statistically significant difference (p<.0001) both for the pre-operative and post-operative sets of values. The correlation between the HKA and FTal was found poor for the preoperative set (R=0.26) and fair for the postoperative one (R=0.53), while the new circles method showed a higher correlation in both the preoperative (R=0.71) and postoperative sets (R=0.79). Intra-observer reliability was high for HKA, FTal and FTa2 on APWB x-rays in the pre- and post-operative setting. Inter

  3. JVM: Java Visual Mapping tool for next generation sequencing read.

    Science.gov (United States)

    Yang, Ye; Liu, Juan

    2015-01-01

    We developed a program JVM (Java Visual Mapping) for mapping next generation sequencing read to reference sequence. The program is implemented in Java and is designed to deal with millions of short read generated by sequence alignment using the Illumina sequencing technology. It employs seed index strategy and octal encoding operations for sequence alignments. JVM is useful for DNA-Seq, RNA-Seq when dealing with single-end resequencing. JVM is a desktop application, which supports reads capacity from 1 MB to 10 GB.

  4. The involvement of long-term serial-order memory in reading development: A longitudinal study.

    Science.gov (United States)

    Bogaerts, Louisa; Szmalec, Arnaud; De Maeyer, Marjolijn; Page, Mike P A; Duyck, Wouter

    2016-05-01

    Recent findings suggest that Hebb repetition learning-a paradigmatic example of long-term serial-order learning-is impaired in adults with dyslexia. The current study further investigated the link between serial-order learning and reading using a longitudinal developmental design. With this aim, verbal and visual Hebb repetition learning performance and reading skills were assessed in 96 Dutch-speaking children who we followed from first through second grade of primary school. We observed a positive association between order learning capacities and reading ability as well as weaker Hebb learning performance in early readers with poor reading skills even at the onset of reading instruction. Hebb learning further predicted individual differences in later (nonword) reading skills. Finally, Hebb learning was shown to explain a significant part of the variance in reading performance above and beyond phonological awareness. These findings highlight the role of serial-order memory in reading ability. Copyright © 2015 Elsevier Inc. All rights reserved.

  5. Reading and company

    DEFF Research Database (Denmark)

    Kuzmičová, Anežka; Dias, Patrícia; Vogrinčič Čepič, Ana

    2017-01-01

    in the environment where one engages in individual silent reading. The primary goal of the study was to explore the role and possible associations of a number of variables (text type, purpose, device) in selecting generic (e.g. indoors vs outdoors) as well as specific (e.g. home vs library) reading environments....... Across all six samples included in the study, participants spontaneously attested to varied, and partly surprising, forms of sensitivity to company and social space in their daily efforts to align body with mind for reading. The article reports these emergent trends and discusses their potential...

  6. Whole genome complete resequencing of Bacillus subtilis natto by combining long reads with high-quality short reads.

    Directory of Open Access Journals (Sweden)

    Mayumi Kamada

    Full Text Available De novo microbial genome sequencing reached a turning point with third-generation sequencing (TGS platforms, and several microbial genomes have been improved by TGS long reads. Bacillus subtilis natto is closely related to the laboratory standard strain B. subtilis Marburg 168, and it has a function in the production of the traditional Japanese fermented food "natto." The B. subtilis natto BEST195 genome was previously sequenced with short reads, but it included some incomplete regions. We resequenced the BEST195 genome using a PacBio RS sequencer, and we successfully obtained a complete genome sequence from one scaffold without any gaps, and we also applied Illumina MiSeq short reads to enhance quality. Compared with the previous BEST195 draft genome and Marburg 168 genome, we found that incomplete regions in the previous genome sequence were attributed to GC-bias and repetitive sequences, and we also identified some novel genes that are found only in the new genome.

  7. Using ESTs for phylogenomics: Can one accurately infer a phylogenetic tree from a gappy alignment?

    Directory of Open Access Journals (Sweden)

    Hartmann Stefanie

    2008-03-01

    Full Text Available Abstract Background While full genome sequences are still only available for a handful of taxa, large collections of partial gene sequences are available for many more. The alignment of partial gene sequences results in a multiple sequence alignment containing large gaps that are arranged in a staggered pattern. The consequences of this pattern of missing data on the accuracy of phylogenetic analysis are not well understood. We conducted a simulation study to determine the accuracy of phylogenetic trees obtained from gappy alignments using three commonly used phylogenetic reconstruction methods (Neighbor Joining, Maximum Parsimony, and Maximum Likelihood and studied ways to improve the accuracy of trees obtained from such datasets. Results We found that the pattern of gappiness in multiple sequence alignments derived from partial gene sequences substantially compromised phylogenetic accuracy even in the absence of alignment error. The decline in accuracy was beyond what would be expected based on the amount of missing data. The decline was particularly dramatic for Neighbor Joining and Maximum Parsimony, where the majority of gappy alignments contained 25% to 40% incorrect quartets. To improve the accuracy of the trees obtained from a gappy multiple sequence alignment, we examined two approaches. In the first approach, alignment masking, potentially problematic columns and input sequences are excluded from from the dataset. Even in the absence of alignment error, masking improved phylogenetic accuracy up to 100-fold. However, masking retained, on average, only 83% of the input sequences. In the second approach, alignment subdivision, the missing data is statistically modelled in order to retain as many sequences as possible in the phylogenetic analysis. Subdivision resulted in more modest improvements to alignment accuracy, but succeeded in including almost all of the input sequences. Conclusion These results demonstrate that partial gene

  8. Using ESTs for phylogenomics: can one accurately infer a phylogenetic tree from a gappy alignment?

    Science.gov (United States)

    Hartmann, Stefanie; Vision, Todd J

    2008-03-26

    While full genome sequences are still only available for a handful of taxa, large collections of partial gene sequences are available for many more. The alignment of partial gene sequences results in a multiple sequence alignment containing large gaps that are arranged in a staggered pattern. The consequences of this pattern of missing data on the accuracy of phylogenetic analysis are not well understood. We conducted a simulation study to determine the accuracy of phylogenetic trees obtained from gappy alignments using three commonly used phylogenetic reconstruction methods (Neighbor Joining, Maximum Parsimony, and Maximum Likelihood) and studied ways to improve the accuracy of trees obtained from such datasets. We found that the pattern of gappiness in multiple sequence alignments derived from partial gene sequences substantially compromised phylogenetic accuracy even in the absence of alignment error. The decline in accuracy was beyond what would be expected based on the amount of missing data. The decline was particularly dramatic for Neighbor Joining and Maximum Parsimony, where the majority of gappy alignments contained 25% to 40% incorrect quartets. To improve the accuracy of the trees obtained from a gappy multiple sequence alignment, we examined two approaches. In the first approach, alignment masking, potentially problematic columns and input sequences are excluded from from the dataset. Even in the absence of alignment error, masking improved phylogenetic accuracy up to 100-fold. However, masking retained, on average, only 83% of the input sequences. In the second approach, alignment subdivision, the missing data is statistically modelled in order to retain as many sequences as possible in the phylogenetic analysis. Subdivision resulted in more modest improvements to alignment accuracy, but succeeded in including almost all of the input sequences. These results demonstrate that partial gene sequences and gappy multiple sequence alignments can pose a

  9. PSI/TM-Coffee: a web server for fast and accurate multiple sequence alignments of regular and transmembrane proteins using homology extension on reduced databases.

    Science.gov (United States)

    Floden, Evan W; Tommaso, Paolo D; Chatzou, Maria; Magis, Cedrik; Notredame, Cedric; Chang, Jia-Ming

    2016-07-08

    The PSI/TM-Coffee web server performs multiple sequence alignment (MSA) of proteins by combining homology extension with a consistency based alignment approach. Homology extension is performed with Position Specific Iterative (PSI) BLAST searches against a choice of redundant and non-redundant databases. The main novelty of this server is to allow databases of reduced complexity to rapidly perform homology extension. This server also gives the possibility to use transmembrane proteins (TMPs) reference databases to allow even faster homology extension on this important category of proteins. Aside from an MSA, the server also outputs topological prediction of TMPs using the HMMTOP algorithm. Previous benchmarking of the method has shown this approach outperforms the most accurate alignment methods such as MSAProbs, Kalign, PROMALS, MAFFT, ProbCons and PRALINE™. The web server is available at http://tcoffee.crg.cat/tmcoffee. © The Author(s) 2016. Published by Oxford University Press on behalf of Nucleic Acids Research.

  10. THE ATLAS INNER DETECTOR TRACK BASED ALIGNMENT

    CERN Document Server

    Marti i Garcia, Salvador; The ATLAS collaboration

    2018-01-01

    The alignment of the ATLAS Inner Detector is performed with a track-based alignment algorithm. Its goal is to provide an accurate description of the detector geometry such that track parameters are accurately determined and free from biases. Its software implementation is modular and configurable, with a clear separation of the alignment algorithm from the detector system specifics and the database handling. The alignment must cope with the rapid movements of the detector as well as with the slow drift of the different mechanical units. Prompt alignment constants are derived for every run at the calibration stage. These sets of constants are then dynamically split from the beginning of the run in many chunks, allowing to describe the tracker geometry as it evolves with time. The alignment of the Inner Detector is validated and improved by studying resonance decays (Z and J/psi to mu+mu-), as well as using information from the calorimeter system with the E/p method with electrons. A detailed study of these res...

  11. How Reading Volume Affects both Reading Fluency and Reading Achievement

    Directory of Open Access Journals (Sweden)

    Richard L. ALLINGTON

    2014-10-01

    Full Text Available Long overlooked, reading volume is actually central to the development of reading proficiencies, especially in the development of fluent reading proficiency. Generally no one in schools monitors the actual volume of reading that children engage in. We know that the commonly used commercial core reading programs provide only material that requires about 15 minutes of reading activity daily. The remaining 75 minute of reading lessons is filled with many other activities such as completing workbook pages or responding to low-level literal questions about what has been read. Studies designed to enhance the volume of reading that children do during their reading lessons demonstrate one way to enhance reading development. Repeated readings have been widely used in fostering reading fluency but wide reading options seem to work faster and more broadly in developing reading proficiencies, including oral reading fluency.

  12. Structure, Function and Diversity of the Healthy Human Microbiome

    Science.gov (United States)

    2012-06-14

    Durbin, R. Fast and accurate long-read alignment with Burrows –Wheeler transform. Bioinformatics 26, 589–595 (2010). 26. Giannoukos, G. et al...Feldgarden2, Victor M. Felix7, Sheila Fisher2, Anthony A. Fodor41, Larry J. Forney42, Leslie Foster6, Valentina Di Francesco19, Jonathan Friedman43

  13. Response to intervention as a predictor of long-term reading outcomes in children with dyslexia

    NARCIS (Netherlands)

    Kleij, S.W. van der; Segers, P.C.J.; Groen, M.A.; Verhoeven, L.T.W.

    2017-01-01

    The goal of this study was to investigate how growth during a phonics-based intervention, as well as reading levels at baseline testing, predicted long-term reading outcomes of children with dyslexia. Eighty Dutch children with dyslexia who had completed a 50-week phonics-based intervention in grade

  14. Performance analysis for W-band antenna alignment using accurate mechanical beam steering

    DEFF Research Database (Denmark)

    Morales Vicente, Alvaro; Rodríguez Páez, Juan Sebastián; Gallardo, Omar

    2017-01-01

    This article presents a study of antenna alignment impact on bit error rate for a wireless link between two directive W-band horn antennas where one of them is mechanically steered by a Stewart platform. Such a technique is applied to find the optimal alignment between transmitter and receiver...... with an accuracy of 18 both in azimuth and elevation angles. The maximum degree of misalignment which can be tolerated is also reported for different values of optical power in the generation of W-band signals by photonic up-conversion. (C) 2017 Wiley Periodicals, Inc....

  15. Swine transcriptome characterization by combined Iso-Seq and RNA-seq for annotating the emerging long read-based reference genome

    Science.gov (United States)

    PacBio long-read sequencing technology is increasingly popular in genome sequence assembly and transcriptome cataloguing. Recently, a new-generation pig reference genome was assembled based on long reads from this technology. To finely annotate this genome assembly, transcriptomes of nine tissues fr...

  16. Objective and Comprehensive Evaluation of Bisulfite Short Read Mapping Tools

    Directory of Open Access Journals (Sweden)

    Hong Tran

    2014-01-01

    Full Text Available Background. Large-scale bisulfite treatment and short reads sequencing technology allow comprehensive estimation of methylation states of Cs in the genomes of different tissues, cell types, and developmental stages. Accurate characterization of DNA methylation is essential for understanding genotype phenotype association, gene and environment interaction, diseases, and cancer. Aligning bisulfite short reads to a reference genome has been a challenging task. We compared five bisulfite short read mapping tools, BSMAP, Bismark, BS-Seeker, BiSS, and BRAT-BW, representing two classes of mapping algorithms (hash table and suffix/prefix tries. We examined their mapping efficiency (i.e., the percentage of reads that can be mapped to the genomes, usability, running time, and effects of changing default parameter settings using both real and simulated reads. We also investigated how preprocessing data might affect mapping efficiency. Conclusion. Among the five programs compared, in terms of mapping efficiency, Bismark performs the best on the real data, followed by BiSS, BSMAP, and finally BRAT-BW and BS-Seeker with very similar performance. If CPU time is not a constraint, Bismark is a good choice of program for mapping bisulfite treated short reads. Data quality impacts a great deal mapping efficiency. Although increasing the number of mismatches allowed can increase mapping efficiency, it not only significantly slows down the program, but also runs the risk of having increased false positives. Therefore, users should carefully set the related parameters depending on the quality of their sequencing data.

  17. 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

  18. Comprehensive evaluation of non-hybrid genome assembly tools for third-generation PacBio long-read sequence data.

    Science.gov (United States)

    Jayakumar, Vasanthan; Sakakibara, Yasubumi

    2017-11-03

    Long reads obtained from third-generation sequencing platforms can help overcome the long-standing challenge of the de novo assembly of sequences for the genomic analysis of non-model eukaryotic organisms. Numerous long-read-aided de novo assemblies have been published recently, which exhibited superior quality of the assembled genomes in comparison with those achieved using earlier second-generation sequencing technologies. Evaluating assemblies is important in guiding the appropriate choice for specific research needs. In this study, we evaluated 10 long-read assemblers using a variety of metrics on Pacific Biosciences (PacBio) data sets from different taxonomic categories with considerable differences in genome size. The results allowed us to narrow down the list to a few assemblers that can be effectively applied to eukaryotic assembly projects. Moreover, we highlight how best to use limited genomic resources for effectively evaluating the genome assemblies of non-model organisms. © The Author 2017. Published by Oxford University Press.

  19. Developmental long trace profiler using optimally aligned mirror based pentaprism

    International Nuclear Information System (INIS)

    Barber, Samuel K.; Morrison, Gregory Y.; Yashchuk, Valeriy V.; Gubarev, Mikhail V.; Geckeler, Ralf D.; Buchheim, Jana; Siewert, Frank; Zeschke, Thomas

    2010-01-01

    A low-budget surface slope measuring instrument, the Developmental Long Trace Profiler (DLTP), was recently brought into operation at the Advanced Light Source Optical Metrology Laboratory (Nucl. Instr. and Meth. A 616, 212-223 (2010)). The instrument is based on a precisely calibrated autocollimator and a movable pentaprism. The capability of the DLTP to achieve sub-microradian surface slope metrology has been verified via cross-comparison measurements with other high-performance slope measuring instruments when measuring the same high-quality test optics. In the present work, a further improvement of the DLTP is achieved by replacing the existing bulk pentaprism with a specially designed mirror based pentaprism. A mirror based pentaprism offers the possibility to eliminate systematic errors introduced by inhomogeneity of the optical material and fabrication imperfections of a bulk pentaprism. We provide the details of the mirror based pentaprism design and describe an original experimental procedure for precision mutual alignment of the mirrors. The algorithm of the alignment procedure and its efficiency are verified with rigorous ray tracing simulations. Results of measurements of a spherically curved test mirror and a flat test mirror using the original bulk pentaprism are compared with measurements using the new mirror based pentaprism, demonstrating the improved performance.

  20. Matching Interventions to Reading Needs: A Case for Differentiation

    Science.gov (United States)

    Jones, Jill S.; Conradi, Kristin; Amendum, Steven J.

    2016-01-01

    The purpose of this article is to highlight the importance of providing reading interventions that are differentiated and aligned with an individual student's most foundational reading skill need. The authors present profiles of different readers and suggest three principal areas for support: decoding words, reading at an appropriate rate, and…

  1. An improved Hough transform-based fingerprint alignment approach

    CSIR Research Space (South Africa)

    Mlambo, CS

    2014-11-01

    Full Text Available An improved Hough Transform based fingerprint alignment approach is presented, which improves computing time and memory usage with accurate alignment parameter (rotation and translation) results. This is achieved by studying the strengths...

  2. Boiler: lossy compression of RNA-seq alignments using coverage vectors.

    Science.gov (United States)

    Pritt, Jacob; Langmead, Ben

    2016-09-19

    We describe Boiler, a new software tool for compressing and querying large collections of RNA-seq alignments. Boiler discards most per-read data, keeping only a genomic coverage vector plus a few empirical distributions summarizing the alignments. Since most per-read data is discarded, storage footprint is often much smaller than that achieved by other compression tools. Despite this, the most relevant per-read data can be recovered; we show that Boiler compression has only a slight negative impact on results given by downstream tools for isoform assembly and quantification. Boiler also allows the user to pose fast and useful queries without decompressing the entire file. Boiler is free open source software available from github.com/jpritt/boiler. © The Author(s) 2016. Published by Oxford University Press on behalf of Nucleic Acids Research.

  3. 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

  4. Fine de novo sequencing of a fungal genome using only SOLiD short read data: verification on Aspergillus oryzae RIB40.

    Directory of Open Access Journals (Sweden)

    Myco Umemura

    Full Text Available The development of next-generation sequencing (NGS technologies has dramatically increased the throughput, speed, and efficiency of genome sequencing. The short read data generated from NGS platforms, such as SOLiD and Illumina, are quite useful for mapping analysis. However, the SOLiD read data with lengths of <60 bp have been considered to be too short for de novo genome sequencing. Here, to investigate whether de novo sequencing of fungal genomes is possible using only SOLiD short read sequence data, we performed de novo assembly of the Aspergillus oryzae RIB40 genome using only SOLiD read data of 50 bp generated from mate-paired libraries with 2.8- or 1.9-kb insert sizes. The assembled scaffolds showed an N50 value of 1.6 Mb, a 22-fold increase than those obtained using only SOLiD short read in other published reports. In addition, almost 99% of the reference genome was accurately aligned by the assembled scaffold fragments in long lengths. The sequences of secondary metabolite biosynthetic genes and clusters, whose products are of considerable interest in fungal studies due to their potential medicinal, agricultural, and cosmetic properties, were also highly reconstructed in the assembled scaffolds. Based on these findings, we concluded that de novo genome sequencing using only SOLiD short reads is feasible and practical for molecular biological study of fungi. We also investigated the effect of filtering low quality data, library insert size, and k-mer size on the assembly performance, and recommend for the assembly use of mild filtered read data where the N50 was not so degraded and the library has an insert size of ∼2.0 kb, and k-mer size 33.

  5. Stochastic sampling of the RNA structural alignment space.

    Science.gov (United States)

    Harmanci, Arif Ozgun; Sharma, Gaurav; Mathews, David H

    2009-07-01

    A novel method is presented for predicting the common secondary structures and alignment of two homologous RNA sequences by sampling the 'structural alignment' space, i.e. the joint space of their alignments and common secondary structures. The structural alignment space is sampled according to a pseudo-Boltzmann distribution based on a pseudo-free energy change that combines base pairing probabilities from a thermodynamic model and alignment probabilities from a hidden Markov model. By virtue of the implicit comparative analysis between the two sequences, the method offers an improvement over single sequence sampling of the Boltzmann ensemble. A cluster analysis shows that the samples obtained from joint sampling of the structural alignment space cluster more closely than samples generated by the single sequence method. On average, the representative (centroid) structure and alignment of the most populated cluster in the sample of structures and alignments generated by joint sampling are more accurate than single sequence sampling and alignment based on sequence alone, respectively. The 'best' centroid structure that is closest to the known structure among all the centroids is, on average, more accurate than structure predictions of other methods. Additionally, cluster analysis identifies, on average, a few clusters, whose centroids can be presented as alternative candidates. The source code for the proposed method can be downloaded at http://rna.urmc.rochester.edu.

  6. GRIM-Filter: Fast seed location filtering in DNA read mapping using processing-in-memory technologies.

    Science.gov (United States)

    Kim, Jeremie S; Senol Cali, Damla; Xin, Hongyi; Lee, Donghyuk; Ghose, Saugata; Alser, Mohammed; Hassan, Hasan; Ergin, Oguz; Alkan, Can; Mutlu, Onur

    2018-05-09

    Seed location filtering is critical in DNA read mapping, a process where billions of DNA fragments (reads) sampled from a donor are mapped onto a reference genome to identify genomic variants of the donor. State-of-the-art read mappers 1) quickly generate possible mapping locations for seeds (i.e., smaller segments) within each read, 2) extract reference sequences at each of the mapping locations, and 3) check similarity between each read and its associated reference sequences with a computationally-expensive algorithm (i.e., sequence alignment) to determine the origin of the read. A seed location filter comes into play before alignment, discarding seed locations that alignment would deem a poor match. The ideal seed location filter would discard all poor match locations prior to alignment such that there is no wasted computation on unnecessary alignments. We propose a novel seed location filtering algorithm, GRIM-Filter, optimized to exploit 3D-stacked memory systems that integrate computation within a logic layer stacked under memory layers, to perform processing-in-memory (PIM). GRIM-Filter quickly filters seed locations by 1) introducing a new representation of coarse-grained segments of the reference genome, and 2) using massively-parallel in-memory operations to identify read presence within each coarse-grained segment. Our evaluations show that for a sequence alignment error tolerance of 0.05, GRIM-Filter 1) reduces the false negative rate of filtering by 5.59x-6.41x, and 2) provides an end-to-end read mapper speedup of 1.81x-3.65x, compared to a state-of-the-art read mapper employing the best previous seed location filtering algorithm. GRIM-Filter exploits 3D-stacked memory, which enables the efficient use of processing-in-memory, to overcome the memory bandwidth bottleneck in seed location filtering. We show that GRIM-Filter significantly improves the performance of a state-of-the-art read mapper. GRIM-Filter is a universal seed location filter that can be

  7. 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...

  8. 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.

  9. A sensitive short read homology search tool for paired-end read sequencing data.

    Science.gov (United States)

    Techa-Angkoon, Prapaporn; Sun, Yanni; Lei, Jikai

    2017-10-16

    Homology search is still a significant step in functional analysis for genomic data. Profile Hidden Markov Model-based homology search has been widely used in protein domain analysis in many different species. In particular, with the fast accumulation of transcriptomic data of non-model species and metagenomic data, profile homology search is widely adopted in integrated pipelines for functional analysis. While the state-of-the-art tool HMMER has achieved high sensitivity and accuracy in domain annotation, the sensitivity of HMMER on short reads declines rapidly. The low sensitivity on short read homology search can lead to inaccurate domain composition and abundance computation. Our experimental results showed that half of the reads were missed by HMMER for a RNA-Seq dataset. Thus, there is a need for better methods to improve the homology search performance for short reads. We introduce a profile homology search tool named Short-Pair that is designed for short paired-end reads. By using an approximate Bayesian approach employing distribution of fragment lengths and alignment scores, Short-Pair can retrieve the missing end and determine true domains. In particular, Short-Pair increases the accuracy in aligning short reads that are part of remote homologs. We applied Short-Pair to a RNA-Seq dataset and a metagenomic dataset and quantified its sensitivity and accuracy on homology search. The experimental results show that Short-Pair can achieve better overall performance than the state-of-the-art methodology of profile homology search. Short-Pair is best used for next-generation sequencing (NGS) data that lack reference genomes. It provides a complementary paired-end read homology search tool to HMMER. The source code is freely available at https://sourceforge.net/projects/short-pair/ .

  10. Targeted assembly of short sequence reads.

    Directory of Open Access Journals (Sweden)

    René L Warren

    Full Text Available As next-generation sequence (NGS production continues to increase, analysis is becoming a significant bottleneck. However, in situations where information is required only for specific sequence variants, it is not necessary to assemble or align whole genome data sets in their entirety. Rather, NGS data sets can be mined for the presence of sequence variants of interest by localized assembly, which is a faster, easier, and more accurate approach. We present TASR, a streamlined assembler that interrogates very large NGS data sets for the presence of specific variants by only considering reads within the sequence space of input target sequences provided by the user. The NGS data set is searched for reads with an exact match to all possible short words within the target sequence, and these reads are then assembled stringently to generate a consensus of the target and flanking sequence. Typically, variants of a particular locus are provided as different target sequences, and the presence of the variant in the data set being interrogated is revealed by a successful assembly outcome. However, TASR can also be used to find unknown sequences that flank a given target. We demonstrate that TASR has utility in finding or confirming genomic mutations, polymorphisms, fusions and integration events. Targeted assembly is a powerful method for interrogating large data sets for the presence of sequence variants of interest. TASR is a fast, flexible and easy to use tool for targeted assembly.

  11. Identification of genomic indels and structural variations using split reads

    Directory of Open Access Journals (Sweden)

    Urban Alexander E

    2011-07-01

    Full Text Available Abstract Background Recent studies have demonstrated the genetic significance of insertions, deletions, and other more complex structural variants (SVs in the human population. With the development of the next-generation sequencing technologies, high-throughput surveys of SVs on the whole-genome level have become possible. Here we present split-read identification, calibrated (SRiC, a sequence-based method for SV detection. Results We start by mapping each read to the reference genome in standard fashion using gapped alignment. Then to identify SVs, we score each of the many initial mappings with an assessment strategy designed to take into account both sequencing and alignment errors (e.g. scoring more highly events gapped in the center of a read. All current SV calling methods have multilevel biases in their identifications due to both experimental and computational limitations (e.g. calling more deletions than insertions. A key aspect of our approach is that we calibrate all our calls against synthetic data sets generated from simulations of high-throughput sequencing (with realistic error models. This allows us to calculate sensitivity and the positive predictive value under different parameter-value scenarios and for different classes of events (e.g. long deletions vs. short insertions. We run our calculations on representative data from the 1000 Genomes Project. Coupling the observed numbers of events on chromosome 1 with the calibrations gleaned from the simulations (for different length events allows us to construct a relatively unbiased estimate for the total number of SVs in the human genome across a wide range of length scales. We estimate in particular that an individual genome contains ~670,000 indels/SVs. Conclusions Compared with the existing read-depth and read-pair approaches for SV identification, our method can pinpoint the exact breakpoints of SV events, reveal the actual sequence content of insertions, and cover the whole

  12. An improved image alignment procedure for high-resolution transmission electron microscopy.

    Science.gov (United States)

    Lin, Fang; Liu, Yan; Zhong, Xiaoyan; Chen, Jianghua

    2010-06-01

    Image alignment is essential for image processing methods such as through-focus exit-wavefunction reconstruction and image averaging in high-resolution transmission electron microscopy. Relative image displacements exist in any experimentally recorded image series due to the specimen drifts and image shifts, hence image alignment for correcting the image displacements has to be done prior to any further image processing. The image displacement between two successive images is determined by the correlation function of the two relatively shifted images. Here it is shown that more accurate image alignment can be achieved by using an appropriate aperture to filter the high-frequency components of the images being aligned, especially for a crystalline specimen with little non-periodic information. For the image series of crystalline specimens with little amorphous, the radius of the filter aperture should be as small as possible, so long as it covers the innermost lattice reflections. Testing with an experimental through-focus series of Si[110] images, the accuracies of image alignment with different correlation functions are compared with respect to the error functions in through-focus exit-wavefunction reconstruction based on the maximum-likelihood method. Testing with image averaging over noisy experimental images from graphene and carbon-nanotube samples, clear and sharp crystal lattice fringes are recovered after applying optimal image alignment. Copyright 2010 Elsevier Ltd. All rights reserved.

  13. Efficient alignment-free DNA barcode analytics.

    Science.gov (United States)

    Kuksa, Pavel; Pavlovic, Vladimir

    2009-11-10

    In this work we consider barcode DNA analysis problems and address them using alternative, alignment-free methods and representations which model sequences as collections of short sequence fragments (features). The methods use fixed-length representations (spectrum) for barcode sequences to measure similarities or dissimilarities between sequences coming from the same or different species. The spectrum-based representation not only allows for accurate and computationally efficient species classification, but also opens possibility for accurate clustering analysis of putative species barcodes and identification of critical within-barcode loci distinguishing barcodes of different sample groups. New alignment-free methods provide highly accurate and fast DNA barcode-based identification and classification of species with substantial improvements in accuracy and speed over state-of-the-art barcode analysis methods. We evaluate our methods on problems of species classification and identification using barcodes, important and relevant analytical tasks in many practical applications (adverse species movement monitoring, sampling surveys for unknown or pathogenic species identification, biodiversity assessment, etc.) On several benchmark barcode datasets, including ACG, Astraptes, Hesperiidae, Fish larvae, and Birds of North America, proposed alignment-free methods considerably improve prediction accuracy compared to prior results. We also observe significant running time improvements over the state-of-the-art methods. Our results show that newly developed alignment-free methods for DNA barcoding can efficiently and with high accuracy identify specimens by examining only few barcode features, resulting in increased scalability and interpretability of current computational approaches to barcoding.

  14. Heap: a highly sensitive and accurate SNP detection tool for low-coverage high-throughput sequencing data

    KAUST Repository

    Kobayashi, Masaaki

    2017-04-20

    Recent availability of large-scale genomic resources enables us to conduct so called genome-wide association studies (GWAS) and genomic prediction (GP) studies, particularly with next-generation sequencing (NGS) data. The effectiveness of GWAS and GP depends on not only their mathematical models, but the quality and quantity of variants employed in the analysis. In NGS single nucleotide polymorphism (SNP) calling, conventional tools ideally require more reads for higher SNP sensitivity and accuracy. In this study, we aimed to develop a tool, Heap, that enables robustly sensitive and accurate calling of SNPs, particularly with a low coverage NGS data, which must be aligned to the reference genome sequences in advance. To reduce false positive SNPs, Heap determines genotypes and calls SNPs at each site except for sites at the both ends of reads or containing a minor allele supported by only one read. Performance comparison with existing tools showed that Heap achieved the highest F-scores with low coverage (7X) restriction-site associated DNA sequencing reads of sorghum and rice individuals. This will facilitate cost-effective GWAS and GP studies in this NGS era. Code and documentation of Heap are freely available from https://github.com/meiji-bioinf/heap (29 March 2017, date last accessed) and our web site (http://bioinf.mind.meiji.ac.jp/lab/en/tools.html (29 March 2017, date last accessed)).

  15. 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.

  16. [Ophthalmologic reading charts : Part 2: Current logarithmically scaled reading charts].

    Science.gov (United States)

    Radner, W

    2016-12-01

    To analyze currently available reading charts regarding print size, logarithmic print size progression, and the background of test-item standardization. For the present study, the following logarithmically scaled reading charts were investigated using a measuring microscope (iNexis VMA 2520; Nikon, Tokyo): Eschenbach, Zeiss, OCULUS, MNREAD (Minnesota Near Reading Test), Colenbrander, and RADNER. Calculations were made according to EN-ISO 8596 and the International Research Council recommendations. Modern reading charts and cards exhibit a logarithmic progression of print sizes. The RADNER reading charts comprise four different cards with standardized test items (sentence optotypes), a well-defined stop criterion, accurate letter sizes, and a high print quality. Numbers and Landolt rings are also given in the booklet. The OCULUS cards have currently been reissued according to recent standards and also exhibit a high print quality. In addition to letters, numbers, Landolt rings, and examples taken from a timetable and the telephone book, sheet music is also offered. The Colenbrander cards use short sentences of 44 characters, including spaces, and exhibit inaccuracy at smaller letter sizes, as do the MNREAD cards. The MNREAD cards use sentences of 60 characters, including spaces, and have a high print quality. Modern reading charts show that international standards can be achieved with test items similar to optotypes, by using recent technology and developing new concepts of test-item standardization. Accurate print sizes, high print quality, and a logarithmic progression should become the minimum requirements for reading charts and reading cards in ophthalmology.

  17. Application of probabilistic modelling for the uncertainty evaluation of alignment measurements of large accelerator magnets assemblies

    Science.gov (United States)

    Doytchinov, I.; Tonnellier, X.; Shore, P.; Nicquevert, B.; Modena, M.; Mainaud Durand, H.

    2018-05-01

    Micrometric assembly and alignment requirements for future particle accelerators, and especially large assemblies, create the need for accurate uncertainty budgeting of alignment measurements. Measurements and uncertainties have to be accurately stated and traceable, to international standards, for metre-long sized assemblies, in the range of tens of µm. Indeed, these hundreds of assemblies will be produced and measured by several suppliers around the world, and will have to be integrated into a single machine. As part of the PACMAN project at CERN, we proposed and studied a practical application of probabilistic modelling of task-specific alignment uncertainty by applying a simulation by constraints calibration method. Using this method, we calibrated our measurement model using available data from ISO standardised tests (10360 series) for the metrology equipment. We combined this model with reference measurements and analysis of the measured data to quantify the actual specific uncertainty of each alignment measurement procedure. Our methodology was successfully validated against a calibrated and traceable 3D artefact as part of an international inter-laboratory study. The validated models were used to study the expected alignment uncertainty and important sensitivity factors in measuring the shortest and longest of the compact linear collider study assemblies, 0.54 m and 2.1 m respectively. In both cases, the laboratory alignment uncertainty was within the targeted uncertainty budget of 12 µm (68% confidence level). It was found that the remaining uncertainty budget for any additional alignment error compensations, such as the thermal drift error due to variation in machine operation heat load conditions, must be within 8.9 µm and 9.8 µm (68% confidence level) respectively.

  18. 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.

  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 Python object-oriented framework for the CMS alignment and calibration data

    CERN Document Server

    Dawes, Joshua Heneage

    2017-01-01

    The Alignment, Calibrations and Databases group at the CMS Experiment delivers Alignment and Calibration Conditions Data to a large set of workflows which process recorded event data and produce simulated events. The current infrastructure for releasing and consuming Conditions Data was designed in the two years of the first LHC long shutdown to respond to use cases from the preceding data-taking period. During the second run of the LHC, new use cases were defined. For the consumption of Conditions Metadata, no common interface existed for the detector experts to use in Python-based custom scripts, resulting in many different querying and transaction management patterns. A new framework has been built to address such use cases: a simple object-oriented tool that detector experts can use to read and write Conditions Metadata when using Oracle and SQLite databases, that provides a homogeneous method of querying across all services. The tool provides mechanisms for segmenting large sets of conditions while relea...

  1. A fast cross-validation method for alignment of electron tomography images based on Beer-Lambert law

    Science.gov (United States)

    Yan, Rui; Edwards, Thomas J.; Pankratz, Logan M.; Kuhn, Richard J.; Lanman, Jason K.; Liu, Jun; Jiang, Wen

    2015-01-01

    In electron tomography, accurate alignment of tilt series is an essential step in attaining high-resolution 3D reconstructions. Nevertheless, quantitative assessment of alignment quality has remained a challenging issue, even though many alignment methods have been reported. Here, we report a fast and accurate method, tomoAlignEval, based on the Beer-Lambert law, for the evaluation of alignment quality. Our method is able to globally estimate the alignment accuracy by measuring the goodness of log-linear relationship of the beam intensity attenuations at different tilt angles. Extensive tests with experimental data demonstrated its robust performance with stained and cryo samples. Our method is not only significantly faster but also more sensitive than measurements of tomogram resolution using Fourier shell correlation method (FSCe/o). From these tests, we also conclude that while current alignment methods are sufficiently accurate for stained samples, inaccurate alignments remain a major limitation for high resolution cryo-electron tomography. PMID:26455556

  2. A fast cross-validation method for alignment of electron tomography images based on Beer-Lambert law.

    Science.gov (United States)

    Yan, Rui; Edwards, Thomas J; Pankratz, Logan M; Kuhn, Richard J; Lanman, Jason K; Liu, Jun; Jiang, Wen

    2015-11-01

    In electron tomography, accurate alignment of tilt series is an essential step in attaining high-resolution 3D reconstructions. Nevertheless, quantitative assessment of alignment quality has remained a challenging issue, even though many alignment methods have been reported. Here, we report a fast and accurate method, tomoAlignEval, based on the Beer-Lambert law, for the evaluation of alignment quality. Our method is able to globally estimate the alignment accuracy by measuring the goodness of log-linear relationship of the beam intensity attenuations at different tilt angles. Extensive tests with experimental data demonstrated its robust performance with stained and cryo samples. Our method is not only significantly faster but also more sensitive than measurements of tomogram resolution using Fourier shell correlation method (FSCe/o). From these tests, we also conclude that while current alignment methods are sufficiently accurate for stained samples, inaccurate alignments remain a major limitation for high resolution cryo-electron tomography. Copyright © 2015 Elsevier Inc. All rights reserved.

  3. 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

  4. A Nordic comparison of national objectives for reading instruction and teachers' responses about actual reading practice

    DEFF Research Database (Denmark)

    Rønberg, Louise; Mejding, Jan

    2014-01-01

    and functional goals in Finland. It appears that the Finnish descriptions are more aligned with current empirical research on reading comprehension. Swedish and Norwegian teachers have the most varied used of both literary and informational text types during a week, whereas Finnish teachers give informational...... texts a higher priority than literary texts – and the opposite is apparent for Danish teachers. The Finnish and Norwegian teachers prioritise activities that enhance students’ oral reading fluency, which is important for reading comprehension development, to a greater extent than teachers in Denmark......This article presents a comparison of the Nordic countries’ official objectives for reading and analyses of 1005 Nordic teachers’ responses regarding their reading instruction. The specificity and transparency vary greatly in the objectives, from broad outlines in Norway to more specific...

  5. Statistical potential-based amino acid similarity matrices for aligning distantly related protein sequences.

    Science.gov (United States)

    Tan, Yen Hock; Huang, He; Kihara, Daisuke

    2006-08-15

    Aligning distantly related protein sequences is a long-standing problem in bioinformatics, and a key for successful protein structure prediction. Its importance is increasing recently in the context of structural genomics projects because more and more experimentally solved structures are available as templates for protein structure modeling. Toward this end, recent structure prediction methods employ profile-profile alignments, and various ways of aligning two profiles have been developed. More fundamentally, a better amino acid similarity matrix can improve a profile itself; thereby resulting in more accurate profile-profile alignments. Here we have developed novel amino acid similarity matrices from knowledge-based amino acid contact potentials. Contact potentials are used because the contact propensity to the other amino acids would be one of the most conserved features of each position of a protein structure. The derived amino acid similarity matrices are tested on benchmark alignments at three different levels, namely, the family, the superfamily, and the fold level. Compared to BLOSUM45 and the other existing matrices, the contact potential-based matrices perform comparably in the family level alignments, but clearly outperform in the fold level alignments. The contact potential-based matrices perform even better when suboptimal alignments are considered. Comparing the matrices themselves with each other revealed that the contact potential-based matrices are very different from BLOSUM45 and the other matrices, indicating that they are located in a different basin in the amino acid similarity matrix space.

  6. Moleculo Long-Read Sequencing Facilitates Assembly and Genomic Binning from Complex Soil Metagenomes

    Energy Technology Data Exchange (ETDEWEB)

    White, Richard Allen; Bottos, Eric M.; Roy Chowdhury, Taniya; Zucker, Jeremy D.; Brislawn, Colin J.; Nicora, Carrie D.; Fansler, Sarah J.; Glaesemann, Kurt R.; Glass, Kevin; Jansson, Janet K.; Langille, Morgan

    2016-06-28

    ABSTRACT

    Soil metagenomics has been touted as the “grand challenge” for metagenomics, as the high microbial diversity and spatial heterogeneity of soils make them unamenable to current assembly platforms. Here, we aimed to improve soil metagenomic sequence assembly by applying the Moleculo synthetic long-read sequencing technology. In total, we obtained 267 Gbp of raw sequence data from a native prairie soil; these data included 109.7 Gbp of short-read data (~100 bp) from the Joint Genome Institute (JGI), an additional 87.7 Gbp of rapid-mode read data (~250 bp), plus 69.6 Gbp (>1.5 kbp) from Moleculo sequencing. The Moleculo data alone yielded over 5,600 reads of >10 kbp in length, and over 95% of the unassembled reads mapped to contigs of >1.5 kbp. Hybrid assembly of all data resulted in more than 10,000 contigs over 10 kbp in length. We mapped three replicate metatranscriptomes derived from the same parent soil to the Moleculo subassembly and found that 95% of the predicted genes, based on their assignments to Enzyme Commission (EC) numbers, were expressed. The Moleculo subassembly also enabled binning of >100 microbial genome bins. We obtained via direct binning the first complete genome, that of “CandidatusPseudomonas sp. strain JKJ-1” from a native soil metagenome. By mapping metatranscriptome sequence reads back to the bins, we found that several bins corresponding to low-relative-abundanceAcidobacteriawere highly transcriptionally active, whereas bins corresponding to high-relative-abundanceVerrucomicrobiawere not. These results demonstrate that Moleculo sequencing provides a significant advance for resolving complex soil microbial communities.

    IMPORTANCESoil microorganisms carry out key processes for life on our planet, including cycling of carbon and other nutrients and supporting growth of plants. However, there is poor molecular-level understanding of their

  7. An optimized protocol for generation and analysis of Ion Proton sequencing reads for RNA-Seq.

    Science.gov (United States)

    Yuan, Yongxian; Xu, Huaiqian; Leung, Ross Ka-Kit

    2016-05-26

    Previous studies compared running cost, time and other performance measures of popular sequencing platforms. However, comprehensive assessment of library construction and analysis protocols for Proton sequencing platform remains unexplored. Unlike Illumina sequencing platforms, Proton reads are heterogeneous in length and quality. When sequencing data from different platforms are combined, this can result in reads with various read length. Whether the performance of the commonly used software for handling such kind of data is satisfactory is unknown. By using universal human reference RNA as the initial material, RNaseIII and chemical fragmentation methods in library construction showed similar result in gene and junction discovery number and expression level estimated accuracy. In contrast, sequencing quality, read length and the choice of software affected mapping rate to a much larger extent. Unspliced aligner TMAP attained the highest mapping rate (97.27 % to genome, 86.46 % to transcriptome), though 47.83 % of mapped reads were clipped. Long reads could paradoxically reduce mapping in junctions. With reference annotation guide, the mapping rate of TopHat2 significantly increased from 75.79 to 92.09 %, especially for long (>150 bp) reads. Sailfish, a k-mer based gene expression quantifier attained highly consistent results with that of TaqMan array and highest sensitivity. We provided for the first time, the reference statistics of library preparation methods, gene detection and quantification and junction discovery for RNA-Seq by the Ion Proton platform. Chemical fragmentation performed equally well with the enzyme-based one. The optimal Ion Proton sequencing options and analysis software have been evaluated.

  8. Fast and accurate phylogeny reconstruction using filtered spaced-word matches

    Science.gov (United States)

    Sohrabi-Jahromi, Salma; Morgenstern, Burkhard

    2017-01-01

    Abstract Motivation: Word-based or ‘alignment-free’ algorithms are increasingly used for phylogeny reconstruction and genome comparison, since they are much faster than traditional approaches that are based on full sequence alignments. Existing alignment-free programs, however, are less accurate than alignment-based methods. Results: We propose Filtered Spaced Word Matches (FSWM), a fast alignment-free approach to estimate phylogenetic distances between large genomic sequences. For a pre-defined binary pattern of match and don’t-care positions, FSWM rapidly identifies spaced word-matches between input sequences, i.e. gap-free local alignments with matching nucleotides at the match positions and with mismatches allowed at the don’t-care positions. We then estimate the number of nucleotide substitutions per site by considering the nucleotides aligned at the don’t-care positions of the identified spaced-word matches. To reduce the noise from spurious random matches, we use a filtering procedure where we discard all spaced-word matches for which the overall similarity between the aligned segments is below a threshold. We show that our approach can accurately estimate substitution frequencies even for distantly related sequences that cannot be analyzed with existing alignment-free methods; phylogenetic trees constructed with FSWM distances are of high quality. A program run on a pair of eukaryotic genomes of a few hundred Mb each takes a few minutes. Availability and Implementation: The program source code for FSWM including a documentation, as well as the software that we used to generate artificial genome sequences are freely available at http://fswm.gobics.de/ Contact: chris.leimeister@stud.uni-goettingen.de Supplementary information: Supplementary data are available at Bioinformatics online. PMID:28073754

  9. Solving the shrinkage-induced PDMS alignment registration issue in multilayer soft lithography

    International Nuclear Information System (INIS)

    Moraes, Christopher; Sun, Yu; Simmons, Craig A

    2009-01-01

    Shrinkage of polydimethylsiloxane (PDMS) complicates alignment registration between layers during multilayer soft lithography fabrication. This often hinders the development of large-scale microfabricated arrayed devices. Here we report a rapid method to construct large-area, multilayered devices with stringent alignment requirements. This technique, which exploits a previously unrecognized aspect of sandwich mold fabrication, improves device yield, enables highly accurate alignment over large areas of multilayered devices and does not require strict regulation of fabrication conditions or extensive calibration processes. To demonstrate this technique, a microfabricated Braille display was developed and characterized. High device yield and accurate alignment within 15 µm were achieved over three layers for an array of 108 Braille units spread over a 6.5 cm 2 area, demonstrating the fabrication of well-aligned devices with greater ease and efficiency than previously possible

  10. CAFE: aCcelerated Alignment-FrEe sequence analysis.

    Science.gov (United States)

    Lu, Yang Young; Tang, Kujin; Ren, Jie; Fuhrman, Jed A; Waterman, Michael S; Sun, Fengzhu

    2017-07-03

    Alignment-free genome and metagenome comparisons are increasingly important with the development of next generation sequencing (NGS) technologies. Recently developed state-of-the-art k-mer based alignment-free dissimilarity measures including CVTree, $d_2^*$ and $d_2^S$ are more computationally expensive than measures based solely on the k-mer frequencies. Here, we report a standalone software, aCcelerated Alignment-FrEe sequence analysis (CAFE), for efficient calculation of 28 alignment-free dissimilarity measures. CAFE allows for both assembled genome sequences and unassembled NGS shotgun reads as input, and wraps the output in a standard PHYLIP format. In downstream analyses, CAFE can also be used to visualize the pairwise dissimilarity measures, including dendrograms, heatmap, principal coordinate analysis and network display. CAFE serves as a general k-mer based alignment-free analysis platform for studying the relationships among genomes and metagenomes, and is freely available at https://github.com/younglululu/CAFE. © The Author(s) 2017. Published by Oxford University Press on behalf of Nucleic Acids Research.

  11. Simulation of beamline alignment operations

    International Nuclear Information System (INIS)

    Annese, C; Miller, M G.

    1999-01-01

    distributions rather than static values. The only way to accurately understand resource utilization and time requirements for a complex industrial application such as alignment, is to utilize simulation tools such as Simprocess to model the system

  12. SFESA: a web server for pairwise alignment refinement by secondary structure shifts.

    Science.gov (United States)

    Tong, Jing; Pei, Jimin; Grishin, Nick V

    2015-09-03

    Protein sequence alignment is essential for a variety of tasks such as homology modeling and active site prediction. Alignment errors remain the main cause of low-quality structure models. A bioinformatics tool to refine alignments is needed to make protein alignments more accurate. We developed the SFESA web server to refine pairwise protein sequence alignments. Compared to the previous version of SFESA, which required a set of 3D coordinates for a protein, the new server will search a sequence database for the closest homolog with an available 3D structure to be used as a template. For each alignment block defined by secondary structure elements in the template, SFESA evaluates alignment variants generated by local shifts and selects the best-scoring alignment variant. A scoring function that combines the sequence score of profile-profile comparison and the structure score of template-derived contact energy is used for evaluation of alignments. PROMALS pairwise alignments refined by SFESA are more accurate than those produced by current advanced alignment methods such as HHpred and CNFpred. In addition, SFESA also improves alignments generated by other software. SFESA is a web-based tool for alignment refinement, designed for researchers to compute, refine, and evaluate pairwise alignments with a combined sequence and structure scoring of alignment blocks. To our knowledge, the SFESA web server is the only tool that refines alignments by evaluating local shifts of secondary structure elements. The SFESA web server is available at http://prodata.swmed.edu/sfesa.

  13. GUIDANCE2: accurate detection of unreliable alignment regions accounting for the uncertainty of multiple parameters.

    Science.gov (United States)

    Sela, Itamar; Ashkenazy, Haim; Katoh, Kazutaka; Pupko, Tal

    2015-07-01

    Inference of multiple sequence alignments (MSAs) is a critical part of phylogenetic and comparative genomics studies. However, from the same set of sequences different MSAs are often inferred, depending on the methodologies used and the assumed parameters. Much effort has recently been devoted to improving the ability to identify unreliable alignment regions. Detecting such unreliable regions was previously shown to be important for downstream analyses relying on MSAs, such as the detection of positive selection. Here we developed GUIDANCE2, a new integrative methodology that accounts for: (i) uncertainty in the process of indel formation, (ii) uncertainty in the assumed guide tree and (iii) co-optimal solutions in the pairwise alignments, used as building blocks in progressive alignment algorithms. We compared GUIDANCE2 with seven methodologies to detect unreliable MSA regions using extensive simulations and empirical benchmarks. We show that GUIDANCE2 outperforms all previously developed methodologies. Furthermore, GUIDANCE2 also provides a set of alternative MSAs which can be useful for downstream analyses. The novel algorithm is implemented as a web-server, available at: http://guidance.tau.ac.il. © The Author(s) 2015. Published by Oxford University Press on behalf of Nucleic Acids Research.

  14. Assessing strategic alignment to improve IT effectiveness

    NARCIS (Netherlands)

    Smits, M.T.; Fairchild, A.M.; Ribbers, P.M.A.; Milis, K.; van Geel, E.; Markus, M.L.; Hampe, J.F.; Gricar, J.; Pucihar, A.; Lenart, G.

    2009-01-01

    A long running challenge in both large and small organizations has been aligning information systems services with business needs. Good alignment is assumed to lead to good business results, but there is a need for good instruments to assess strategic alignment and business success in practice.

  15. NanoPack: visualizing and processing long read sequencing data.

    Science.gov (United States)

    De Coster, Wouter; D'Hert, Svenn; Schultz, Darrin T; Cruts, Marc; Van Broeckhoven, Christine

    2018-03-14

    Here we describe NanoPack, a set of tools developed for visualization and processing of long read sequencing data from Oxford Nanopore Technologies and Pacific Biosciences. The NanoPack tools are written in Python3 and released under the GNU GPL3.0 License. The source code can be found at https://github.com/wdecoster/nanopack, together with links to separate scripts and their documentation. The scripts are compatible with Linux, Mac OS and the MS Windows 10 subsystem for Linux and are available as a graphical user interface, a web service at http://nanoplot.bioinf.be and command line tools. wouter.decoster@molgen.vib-ua.be. Supplementary tables and figures are available at Bioinformatics online.

  16. Hohlraum Target Alignment from X-ray Detector Images using Starburst Design Patterns

    International Nuclear Information System (INIS)

    Leach, R.R.; Conder, A.; Edwards, O.; Kroll, J.; Kozioziemski, B.; Mapoles, E.; McGuigan, D.; Wilhelmsen, K.

    2010-01-01

    National Ignition Facility (NIF) is a high-energy laser facility comprised of 192 laser beams focused with enough power and precision on a hydrogen-filled spherical, cryogenic target to initiate a fusion reaction. The target container, or hohlraum, must be accurately aligned to an x-ray imaging system to allow careful monitoring of the frozen fuel layer in the target. To achieve alignment, x-ray images are acquired through starburst-shaped windows cut into opposite sides of the hohlraum. When the hohlraum is in alignment, the starburst pattern pairs match nearly exactly and allow a clear view of the ice layer formation on the edge of the target capsule. During the alignment process, x-ray image analysis is applied to determine the direction and magnitude of adjustment required. X-ray detector and source are moved in concert during the alignment process. The automated pointing alignment system described here is both accurate and efficient. In this paper, we describe the control and associated image processing that enables automation of the starburst pointing alignment.

  17. The Importance of Metacognitive Reading Strategy Awareness in Reading Comprehension

    Science.gov (United States)

    Ahmadi, Mohammad Reza; Ismail, Hairul Nizam; Abdullah, Muhammad Kamarul Kabilan

    2013-01-01

    Metacognitive reading strategy awareness plays a significant role in reading comprehension and educational process. In spite of its importance, metacognitive strategy has long been the ignored skill in English language teaching, research, learning, and assessment. This lack of good metacognitive reading strategy skill is exacerbated by the central…

  18. Initial Alignment for SINS Based on Pseudo-Earth Frame in Polar Regions.

    Science.gov (United States)

    Gao, Yanbin; Liu, Meng; Li, Guangchun; Guang, Xingxing

    2017-06-16

    An accurate initial alignment must be required for inertial navigation system (INS). The performance of initial alignment directly affects the following navigation accuracy. However, the rapid convergence of meridians and the small horizontalcomponent of rotation of Earth make the traditional alignment methods ineffective in polar regions. In this paper, from the perspective of global inertial navigation, a novel alignment algorithm based on pseudo-Earth frame and backward process is proposed to implement the initial alignment in polar regions. Considering that an accurate coarse alignment of azimuth is difficult to obtain in polar regions, the dynamic error modeling with large azimuth misalignment angle is designed. At the end of alignment phase, the strapdown attitude matrix relative to local geographic frame is obtained without influence of position errors and cumbersome computation. As a result, it would be more convenient to access the following polar navigation system. Then, it is also expected to unify the polar alignment algorithm as much as possible, thereby further unifying the form of external reference information. Finally, semi-physical static simulation and in-motion tests with large azimuth misalignment angle assisted by unscented Kalman filter (UKF) validate the effectiveness of the proposed method.

  19. A handy time alignment probe for timing calibration of PET scanners

    International Nuclear Information System (INIS)

    Bergeron, Melanie; Pepin, Catherine M.; Arpin, Louis; Leroux, Jean-Daniel; Tetrault, Marc-Andre; Viscogliosi, Nicolas; Fontaine, Rejean; Lecomte, Roger

    2009-01-01

    Accurate time alignment of detectors in PET scanners is required for improving overall coincidence timing resolution. This is mandatory to reduce the coincidence time window of the scanner and limit as much as possible the rate of random events in images. Several techniques have been proposed so far, but most have shortcomings relating to difficult use, collection of huge amount of data or long acquisition times, not to mention transport regulation of radioactive source embedded in time alignment probes. A handy liquid scintillation beta probe was developed to overcome these problems. It consists of a PMT coupled to a small glass container that can be filled with a liquid scintillation cocktail loaded with radioactivity (such as 18 F). The PMT signal is processed by an analog CFD and a digital TDC supplying an accurate timestamp on positron detection. When tested in coincidence with a fast PMT/plastic detector, a timing resolution of 1.1 ns FWHM was obtained using a standard off-the-shelf liquid cocktail having a scintillation decay time of 6.2 ns. For time alignment, coincidences are recorded between positron detected by the probe and one of the two 511 keV annihilation photons reaching detectors in the scanner. Using this simple probe, it is possible to determine the time offsets for individual LYSO and LGSO crystals in LabPET TM scanners in about 15 min. Due to its ease of use and short acquisition time, the proposed timing calibration method was found ideal for tuning the APD bias of individual detectors to reach optimal timing resolution on every channel.

  20. Computer Vision Syndrome for Non-Native Speaking Students: What Are the Problems with Online Reading?

    Science.gov (United States)

    Tseng, Min-chen

    2014-01-01

    This study investigated the online reading performances and the level of visual fatigue from the perspectives of non-native speaking students (NNSs). Reading on a computer screen is more visually more demanding than reading printed text. Online reading requires frequent saccadic eye movements and imposes continuous focusing and alignment demand.…

  1. SPA: a probabilistic algorithm for spliced alignment.

    Directory of Open Access Journals (Sweden)

    2006-04-01

    Full Text Available Recent large-scale cDNA sequencing efforts show that elaborate patterns of splice variation are responsible for much of the proteome diversity in higher eukaryotes. To obtain an accurate account of the repertoire of splice variants, and to gain insight into the mechanisms of alternative splicing, it is essential that cDNAs are very accurately mapped to their respective genomes. Currently available algorithms for cDNA-to-genome alignment do not reach the necessary level of accuracy because they use ad hoc scoring models that cannot correctly trade off the likelihoods of various sequencing errors against the probabilities of different gene structures. Here we develop a Bayesian probabilistic approach to cDNA-to-genome alignment. Gene structures are assigned prior probabilities based on the lengths of their introns and exons, and based on the sequences at their splice boundaries. A likelihood model for sequencing errors takes into account the rates at which misincorporation, as well as insertions and deletions of different lengths, occurs during sequencing. The parameters of both the prior and likelihood model can be automatically estimated from a set of cDNAs, thus enabling our method to adapt itself to different organisms and experimental procedures. We implemented our method in a fast cDNA-to-genome alignment program, SPA, and applied it to the FANTOM3 dataset of over 100,000 full-length mouse cDNAs and a dataset of over 20,000 full-length human cDNAs. Comparison with the results of four other mapping programs shows that SPA produces alignments of significantly higher quality. In particular, the quality of the SPA alignments near splice boundaries and SPA's mapping of the 5' and 3' ends of the cDNAs are highly improved, allowing for more accurate identification of transcript starts and ends, and accurate identification of subtle splice variations. Finally, our splice boundary analysis on the human dataset suggests the existence of a novel non

  2. 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...

  3. Orthographic learning in children with isolated and combined reading and spelling deficits.

    Science.gov (United States)

    Mehlhase, Heike; Bakos, Sarolta; Landerl, Karin; Schulte-Körne, Gerd; Moll, Kristina

    2018-05-07

    Dissociations between reading and spelling problems are likely to be associated with different underlying cognitive deficits, and with different deficits in orthographic learning. In order to understand these differences, the current study examined orthographic learning using a printed-word learning paradigm. Children (4th grade) with isolated reading, isolated spelling and combined reading and spelling problems were compared to children with age appropriate reading and spelling skills on their performance during learning novel words and symbols (non-verbal control condition), and during immediate and delayed reading and spelling recall tasks. No group differences occurred in the non-verbal control condition. In the verbal condition, initial learning was intact in all groups, but differences occurred during recall tasks. Children with reading fluency deficits showed slower reading times, while children with spelling deficits were less accurate, both in reading and spelling recall. Children with isolated spelling problems showed no difficulties in immediate spelling recall, but had problems in remembering the spellings 2 hours later. The results suggest that different orthographic learning deficits underlie reading fluency and spelling problems: Children with isolated reading fluency deficits have no difficulties in building-up orthographic representations, but access to these representations is slowed down while children with isolated spelling deficits have problems in storing precise orthographic representations in long-term memory.

  4. Tibial Bowing and Pseudarthrosis in Neurofibromatosis Type 1

    Science.gov (United States)

    2015-01-01

    exposed to the vector. Larry Sherman (Oregon Health and Science University) dis- cussed the underlyingmechanisms of pain in schwannomatosis.He...Sequence reads were mapped using the Burrow -Wheeler aligner (9) and final alignments generated after multiple quality controls steps applied using...Li H, Durbin R. Fast and accurate short read alignment with Burrows -Wheeler transform. Bioinformatics 2009;25(14):1754-60. 10. McKenna A, Hanna M

  5. Morpheme-based Reading and Spelling in Italian Children with Developmental Dyslexia and Dysorthography.

    Science.gov (United States)

    Angelelli, Paola; Marinelli, Chiara Valeria; De Salvatore, Marinella; Burani, Cristina

    2017-11-01

    Italian sixth graders, with and without dyslexia, read pseudowords and low-frequency words that include high-frequency morphemes better than stimuli not including any morpheme. The present study assessed whether morphemes affect (1) younger children, with and without dyslexia; (2) spelling as well as reading; and (3) words with low-frequency morphemes. Two groups of third graders (16 children with dyslexia and dysorthography and 16 age-matched typically developing children) read aloud and spelt to dictation pseudowords and words. Pseudowords included (1) root + suffix in not existing combinations (e.g. lampadista, formed by lampad-, 'lamp', and -ista, '-ist') and (2) orthographic sequences not corresponding to any Italian root or suffix (e.g. livonosto). Words had low frequency and included: (1) root + suffix, both of high frequency (e.g. bestiale, 'beastly'); (2) root + suffix, both of low frequency (e.g. asprigno, 'rather sour'); and (3) simple words (e.g. insulso, 'vapid'). Children with dyslexia and dysorthography were less accurate than typically developing children. Root + suffix pseudowords were read and spelt more accurately than non-morphological pseudowords by both groups. Morphologically complex (root + suffix) words were read and spelt better than simple words. However, task interacted with morphology: reading was not facilitated by low-frequency morphemes. We conclude that children acquiring a transparent orthography exploit morpheme-based reading and spelling to face difficulties in processing long unfamiliar stimuli. Copyright © 2017 John Wiley & Sons, Ltd. Copyright © 2017 John Wiley & Sons, Ltd.

  6. 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...

  7. Accurate Typing of Human Leukocyte Antigen Class I Genes by Oxford Nanopore Sequencing.

    Science.gov (United States)

    Liu, Chang; Xiao, Fangzhou; Hoisington-Lopez, Jessica; Lang, Kathrin; Quenzel, Philipp; Duffy, Brian; Mitra, Robi David

    2018-04-03

    Oxford Nanopore Technologies' MinION has expanded the current DNA sequencing toolkit by delivering long read lengths and extreme portability. The MinION has the potential to enable expedited point-of-care human leukocyte antigen (HLA) typing, an assay routinely used to assess the immunologic compatibility between organ donors and recipients, but the platform's high error rate makes it challenging to type alleles with accuracy. We developed and validated accurate typing of HLA by Oxford nanopore (Athlon), a bioinformatic pipeline that i) maps nanopore reads to a database of known HLA alleles, ii) identifies candidate alleles with the highest read coverage at different resolution levels that are represented as branching nodes and leaves of a tree structure, iii) generates consensus sequences by remapping the reads to the candidate alleles, and iv) calls the final diploid genotype by blasting consensus sequences against the reference database. Using two independent data sets generated on the R9.4 flow cell chemistry, Athlon achieved a 100% accuracy in class I HLA typing at the two-field resolution. Copyright © 2018 American Society for Investigative Pathology and the Association for Molecular Pathology. Published by Elsevier Inc. All rights reserved.

  8. Reading Prosody in Spanish Dyslexics

    Science.gov (United States)

    Suárez-Coalla, Paz; Álvarez-Cañizo, Marta; Martínez, Cristina; García, Noemí; Cuetos, Fernando

    2016-01-01

    Reading becomes expressive when word and text reading are quick, accurate and automatic. Recent studies have reported that skilled readers use greater pitch changes and fewer irrelevant pauses than poor readers. Given that developmental dyslexics have difficulty acquiring and automating the alphabetic code and developing orthographic…

  9. Fiber optics welder having movable aligning mirror

    Science.gov (United States)

    Higgins, Robert W.; Robichaud, Roger E.

    1981-01-01

    A system for welding fiber optic waveguides together. The ends of the two fibers to be joined together are accurately, collinearly aligned in a vertical orientation and subjected to a controlled, diffuse arc to effect welding and thermal conditioning. A front-surfaced mirror mounted at a 45.degree. angle to the optical axis of a stereomicroscope mounted for viewing the junction of the ends provides two orthogonal views of the interface during the alignment operation.

  10. The influences of working memory representations on long-range regression in text reading: An eye-tracking study

    Directory of Open Access Journals (Sweden)

    Teppei eTanaka

    2014-09-01

    Full Text Available The present study investigated the relationship between verbal and visuospatial working memory capacity and long-range regression (i.e., word relocation processes in reading. We analyzed eye movements during a whodunit task, in which readers were asked to answer a content question while original text was being presented. The eye movements were more efficient in relocating a target word when the target was at recency positions within the text than when it was at primacy positions. Furthermore, both verbal and visuospatial working memory capacity partly predicted the efficiency of the initial long-range regression. The results indicate that working memory representations have a strong influence at the first stage of long-range regression by driving the first saccade movement toward the correct target position, suggesting that there is a dynamic interaction between internal working memory representations and external actions during text reading.

  11. Alignment of the HERA-B RICH optical system with data

    International Nuclear Information System (INIS)

    Gorisek, A.; Krizan, P.; Korpar, S.; Staric, M.

    1999-01-01

    We present a method for alignment of the mirror segments in the Ring Image Cherenkov Counter of the HERA-B spectrometer. The method will use recorded data, and was tested by using simulated events. The study shows that the mirrors can be aligned accurately enough to make the corresponding error in Cherenkov angle measurement negligible compared to other contributions. The mirrors are aligned relative to one mirror segment which can be chosen arbitrarily

  12. T-BAS: Tree-Based Alignment Selector toolkit for phylogenetic-based placement, alignment downloads and metadata visualization: an example with the Pezizomycotina tree of life.

    Science.gov (United States)

    Carbone, Ignazio; White, James B; Miadlikowska, Jolanta; Arnold, A Elizabeth; Miller, Mark A; Kauff, Frank; U'Ren, Jana M; May, Georgiana; Lutzoni, François

    2017-04-15

    High-quality phylogenetic placement of sequence data has the potential to greatly accelerate studies of the diversity, systematics, ecology and functional biology of diverse groups. We developed the Tree-Based Alignment Selector (T-BAS) toolkit to allow evolutionary placement and visualization of diverse DNA sequences representing unknown taxa within a robust phylogenetic context, and to permit the downloading of highly curated, single- and multi-locus alignments for specific clades. In its initial form, T-BAS v1.0 uses a core phylogeny of 979 taxa (including 23 outgroup taxa, as well as 61 orders, 175 families and 496 genera) representing all 13 classes of largest subphylum of Fungi-Pezizomycotina (Ascomycota)-based on sequence alignments for six loci (nr5.8S, nrLSU, nrSSU, mtSSU, RPB1, RPB2 ). T-BAS v1.0 has three main uses: (i) Users may download alignments and voucher tables for members of the Pezizomycotina directly from the reference tree, facilitating systematics studies of focal clades. (ii) Users may upload sequence files with reads representing unknown taxa and place these on the phylogeny using either BLAST or phylogeny-based approaches, and then use the displayed tree to select reference taxa to include when downloading alignments. The placement of unknowns can be performed for large numbers of Sanger sequences obtained from fungal cultures and for alignable, short reads of environmental amplicons. (iii) User-customizable metadata can be visualized on the tree. T-BAS Version 1.0 is available online at http://tbas.hpc.ncsu.edu . Registration is required to access the CIPRES Science Gateway and NSF XSEDE's large computational resources. icarbon@ncsu.edu. 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

  13. Ancestral sequence alignment under optimal conditions

    Directory of Open Access Journals (Sweden)

    Brown Daniel G

    2005-11-01

    success of aligning ancestral sequences containing ambiguity is very sensitive to the choice of gap open cost. Surprisingly, we find that using maximum likelihood to infer ancestral sequences results in less accurate alignments than when using parsimony to infer ancestral sequences. Finally, we find that the sum-of-pairs methods produce better alignments than all of the ancestral alignment methods.

  14. A stochastic de novo assembly algorithm for viral-sized genomes obtains correct genomes and builds consensus

    NARCIS (Netherlands)

    Bucur, Doina

    2017-01-01

    A genetic algorithm with stochastic macro mutation operators which merge, split, move, reverse and align DNA contigs on a scaffold is shown to accurately and consistently assemble raw DNA reads from an accurately sequenced single-read library into a contiguous genome. A candidate solution is a

  15. A Benchmark Study on Error Assessment and Quality Control of CCS Reads Derived from the PacBio RS.

    Science.gov (United States)

    Jiao, Xiaoli; Zheng, Xin; Ma, Liang; Kutty, Geetha; Gogineni, Emile; Sun, Qiang; Sherman, Brad T; Hu, Xiaojun; Jones, Kristine; Raley, Castle; Tran, Bao; Munroe, David J; Stephens, Robert; Liang, Dun; Imamichi, Tomozumi; Kovacs, Joseph A; Lempicki, Richard A; Huang, Da Wei

    2013-07-31

    PacBio RS, a newly emerging third-generation DNA sequencing platform, is based on a real-time, single-molecule, nano-nitch sequencing technology that can generate very long reads (up to 20-kb) in contrast to the shorter reads produced by the first and second generation sequencing technologies. As a new platform, it is important to assess the sequencing error rate, as well as the quality control (QC) parameters associated with the PacBio sequence data. In this study, a mixture of 10 prior known, closely related DNA amplicons were sequenced using the PacBio RS sequencing platform. After aligning Circular Consensus Sequence (CCS) reads derived from the above sequencing experiment to the known reference sequences, we found that the median error rate was 2.5% without read QC, and improved to 1.3% with an SVM based multi-parameter QC method. In addition, a De Novo assembly was used as a downstream application to evaluate the effects of different QC approaches. This benchmark study indicates that even though CCS reads are post error-corrected it is still necessary to perform appropriate QC on CCS reads in order to produce successful downstream bioinformatics analytical results.

  16. Centroid based clustering of high throughput sequencing reads based on n-mer counts.

    Science.gov (United States)

    Solovyov, Alexander; Lipkin, W Ian

    2013-09-08

    Many problems in computational biology require alignment-free sequence comparisons. One of the common tasks involving sequence comparison is sequence clustering. Here we apply methods of alignment-free comparison (in particular, comparison using sequence composition) to the challenge of sequence clustering. We study several centroid based algorithms for clustering sequences based on word counts. Study of their performance shows that using k-means algorithm with or without the data whitening is efficient from the computational point of view. A higher clustering accuracy can be achieved using the soft expectation maximization method, whereby each sequence is attributed to each cluster with a specific probability. We implement an open source tool for alignment-free clustering. It is publicly available from github: https://github.com/luscinius/afcluster. We show the utility of alignment-free sequence clustering for high throughput sequencing analysis despite its limitations. In particular, it allows one to perform assembly with reduced resources and a minimal loss of quality. The major factor affecting performance of alignment-free read clustering is the length of the read.

  17. The Development of the easyCBM CCSS Reading Assessments: Grade 3. Technical Report #1221

    Science.gov (United States)

    Alonzo, Julie; Park, Bitnara Jasmine; Tindal, Gerald

    2012-01-01

    In this technical report, we document the development and piloting of easyCBM reading measures aligned to the Common Core State Standards, designed for use in screening students at risk for reading difficulty and monitoring their progress as they develop reading skills. The measures, which assess students' ability to respond to…

  18. Teachers' Basic Knowledge of Reading Instruction: Insights from a Teacher Preparation Program

    Science.gov (United States)

    Berkeley, Sheri; Regan, Kelley; Dimitrov, Dimiter; Guckert, Mary; Ray, Sharon

    2016-01-01

    Effective reading instruction is essential for all students, and especially students with disabilities; however, studies have indicated that both pre-service and in-service teachers lack an adequate knowledge of reading. To ensure adequate teacher knowledge, teacher preparation reform advocates suggest purposeful alignment of teacher preparation…

  19. Three Planes of Practice: Examining Intersections of Reading Identity and Pedagogy

    Science.gov (United States)

    Bernstein, Malayna

    2014-01-01

    This paper reports on a project that examined teachers' reading identities and explored ways in which those identities were manifested in reading pedagogy and were adopted by students. The paper focuses on one purposively selected teacher and his class. Tom Ziegler's personal and pedagogical practices were deeply aligned, and his…

  20. Exploring the relationship between sequence similarity and accurate phylogenetic trees.

    Science.gov (United States)

    Cantarel, Brandi L; Morrison, Hilary G; Pearson, William

    2006-11-01

    We have characterized the relationship between accurate phylogenetic reconstruction and sequence similarity, testing whether high levels of sequence similarity can consistently produce accurate evolutionary trees. We generated protein families with known phylogenies using a modified version of the PAML/EVOLVER program that produces insertions and deletions as well as substitutions. Protein families were evolved over a range of 100-400 point accepted mutations; at these distances 63% of the families shared significant sequence similarity. Protein families were evolved using balanced and unbalanced trees, with ancient or recent radiations. In families sharing statistically significant similarity, about 60% of multiple sequence alignments were 95% identical to true alignments. To compare recovered topologies with true topologies, we used a score that reflects the fraction of clades that were correctly clustered. As expected, the accuracy of the phylogenies was greatest in the least divergent families. About 88% of phylogenies clustered over 80% of clades in families that shared significant sequence similarity, using Bayesian, parsimony, distance, and maximum likelihood methods. However, for protein families with short ancient branches (ancient radiation), only 30% of the most divergent (but statistically significant) families produced accurate phylogenies, and only about 70% of the second most highly conserved families, with median expectation values better than 10(-60), produced accurate trees. These values represent upper bounds on expected tree accuracy for sequences with a simple divergence history; proteins from 700 Giardia families, with a similar range of sequence similarities but considerably more gaps, produced much less accurate trees. For our simulated insertions and deletions, correct multiple sequence alignments did not perform much better than those produced by T-COFFEE, and including sequences with expressed sequence tag-like sequencing errors did not

  1. Alignment of the ATLAS Inner Detector Tracking System

    CERN Document Server

    Lacuesta, V; The ATLAS collaboration

    2010-01-01

    ATLAS is a multipurpose experiment that records the LHC collisions. To reconstruct trajectories of charged particles produced in these collisions, ATLAS tracking system is equipped with silicon planar sensors and drift‐tube based detectors. They constitute the ATLAS Inner Detector. In order to achieve its scientific goals, the alignment of the ATLAS tracking system requires the determine accurately its almost 36000 degrees of freedom. Thus the demanded precision for the alignment of the silicon sensors is below 10 micrometers. This implies to use a large sample of high momentum and isolated charge particle tracks. The high level trigger selects those tracks online. Then the raw data with the hits information of the triggered tracks is stored in a calibration stream. Tracks from cosmic trigger during empty LHC bunches are also used as input for the alignment. The implementation of the track based alignment within the ATLAS software framework unifies different alignment approaches and allows the alignment of ...

  2. 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

  3. Image Alignment for Multiple Camera High Dynamic Range Microscopy.

    Science.gov (United States)

    Eastwood, Brian S; Childs, Elisabeth C

    2012-01-09

    This paper investigates the problem of image alignment for multiple camera high dynamic range (HDR) imaging. HDR imaging combines information from images taken with different exposure settings. Combining information from multiple cameras requires an alignment process that is robust to the intensity differences in the images. HDR applications that use a limited number of component images require an alignment technique that is robust to large exposure differences. We evaluate the suitability for HDR alignment of three exposure-robust techniques. We conclude that image alignment based on matching feature descriptors extracted from radiant power images from calibrated cameras yields the most accurate and robust solution. We demonstrate the use of this alignment technique in a high dynamic range video microscope that enables live specimen imaging with a greater level of detail than can be captured with a single camera.

  4. Reading Intervention and Special Education Referrals

    Science.gov (United States)

    Polcyn, Dawn M.; Levine-Donnerstein, Deborah; Perfect, Michelle M.; Obrzut, John E.

    2014-01-01

    This study examined whether consistently implementing reading fluency interventions prior to referring students for a special education evaluation led to fewer overall special education referrals, as well as more accurate special education referrals. Results indicated that the implementation of a peer-mediated reading fluency intervention…

  5. 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.

  6. 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

  7. Design of practical alignment device in KSTAR Thomson diagnostic

    Energy Technology Data Exchange (ETDEWEB)

    Lee, J. H., E-mail: jhlee@nfri.re.kr [National Fusion Research Institute, Daejeon (Korea, Republic of); University of Science and Technology (UST), Daejeon (Korea, Republic of); Lee, S. H. [National Fusion Research Institute, Daejeon (Korea, Republic of); Yamada, I. [National Institute for Fusion Science, Toki (Japan)

    2016-11-15

    The precise alignment of the laser path and collection optics in Thomson scattering measurements is essential for accurately determining electron temperature and density in tokamak experiments. For the last five years, during the development stage, the KSTAR tokamak’s Thomson diagnostic system has had alignment fibers installed in its optical collection modules, but these lacked a proper alignment detection system. In order to address these difficulties, an alignment verifying detection device between lasers and an object field of collection optics is developed. The alignment detection device utilizes two types of filters: a narrow laser band wavelength for laser, and a broad wavelength filter for Thomson scattering signal. Four such alignment detection devices have been successfully developed for the KSTAR Thomson scattering system in this year, and these will be tested in KSTAR experiments in 2016. In this paper, we present the newly developed alignment detection device for KSTAR’s Thomson scattering diagnostics.

  8. "Passageless" Administration of the Nelson-Denny Reading Comprehension Test: Associations with IQ and Reading Skills

    Science.gov (United States)

    Ready, Rebecca E.; Chaudhry, Maheen F.; Schatz, Kelly C.; Strazzullo, Sarah

    2013-01-01

    There are few tests that assess reading comprehension in adults, but these tests are needed for a comprehensive assessment of reading disorders (RD). "The Nelson-Denny Reading Test" (NDRT) has a long-passage reading comprehension component that can be used with adolescents and adults. A problem with the NDRT is that reading comprehension…

  9. Anatomically Plausible Surface Alignment and Reconstruction

    DEFF Research Database (Denmark)

    Paulsen, Rasmus R.; Larsen, Rasmus

    2010-01-01

    With the increasing clinical use of 3D surface scanners, there is a need for accurate and reliable algorithms that can produce anatomically plausible surfaces. In this paper, a combined method for surface alignment and reconstruction is proposed. It is based on an implicit surface representation...

  10. Multiple sequence alignment accuracy and phylogenetic inference.

    Science.gov (United States)

    Ogden, T Heath; Rosenberg, Michael S

    2006-04-01

    Phylogenies are often thought to be more dependent upon the specifics of the sequence alignment rather than on the method of reconstruction. Simulation of sequences containing insertion and deletion events was performed in order to determine the role that alignment accuracy plays during phylogenetic inference. Data sets were simulated for pectinate, balanced, and random tree shapes under different conditions (ultrametric equal branch length, ultrametric random branch length, nonultrametric random branch length). Comparisons between hypothesized alignments and true alignments enabled determination of two measures of alignment accuracy, that of the total data set and that of individual branches. In general, our results indicate that as alignment error increases, topological accuracy decreases. This trend was much more pronounced for data sets derived from more pectinate topologies. In contrast, for balanced, ultrametric, equal branch length tree shapes, alignment inaccuracy had little average effect on tree reconstruction. These conclusions are based on average trends of many analyses under different conditions, and any one specific analysis, independent of the alignment accuracy, may recover very accurate or inaccurate topologies. Maximum likelihood and Bayesian, in general, outperformed neighbor joining and maximum parsimony in terms of tree reconstruction accuracy. Results also indicated that as the length of the branch and of the neighboring branches increase, alignment accuracy decreases, and the length of the neighboring branches is the major factor in topological accuracy. Thus, multiple-sequence alignment can be an important factor in downstream effects on topological reconstruction.

  11. Dyslexie font does not benefit reading in children with or without dyslexia.

    Science.gov (United States)

    Kuster, Sanne M; van Weerdenburg, Marjolijn; Gompel, Marjolein; Bosman, Anna M T

    2017-12-04

    In two experiments, the claim was tested that the font "Dyslexie", specifically designed for people with dyslexia, eases reading performance of children with (and without) dyslexia. Three questions were investigated. (1) Does the Dyslexie font lead to faster and/or more accurate reading? (2) Do children have a preference for the Dyslexie font? And, (3) is font preference related to reading performance? In Experiment 1, children with dyslexia (n = 170) did not read text written in Dyslexie font faster or more accurately than in Arial font. The majority preferred reading in Arial and preference was not related to reading performance. In Experiment 2, children with (n = 102) and without dyslexia (n = 45) read word lists in three different font types (Dyslexie, Arial, Times New Roman). Words written in Dyslexie font were not read faster or more accurately. Moreover, participants showed a preference for the fonts Arial and Times New Roman rather than Dyslexie, and again, preference was not related to reading performance. These experiments clearly justify the conclusion that the Dyslexie font neither benefits nor impedes the reading process of children with and without dyslexia.

  12. Adult EFL Reading Selection: Influence on Literacy

    Directory of Open Access Journals (Sweden)

    Juan Sebastián Basallo Gómez

    2016-01-01

    Full Text Available This paper is about the impact of systematic reading selection used to promote English as foreign language learning in adult students. A qualitative action research methodology was used to carry out this project. Ten class sessions were designed to provide students an opportunity to select texts according to criteria based upon their language levels and personal/professional interests. The findings align with three categories of influence: motivation, engagement, and contextualization/interpretation of readings. The main objective of this project was to see how the students’ text selection processes, guided by systematically designed criteria and elaborated strategies, influenced learning and acquisition in terms of motivation, perceptions, and opinions towards reading in English.

  13. How to assess and improve children's reading comprehension?

    OpenAIRE

    Muijselaar, M.M.L.

    2016-01-01

    Reading comprehension is one of the most important skills children have to acquire during the final years of primary education. It is therefore unfortunate that many children have severe problems with a proper understanding of texts. To design methods that foster children’s reading comprehension, more information about the underlying skills and processes that are involved in reading comprehension is needed. Prerequisites for reading comprehension are the accurate and fast reading of single wo...

  14. Rcount: simple and flexible RNA-Seq read counting.

    Science.gov (United States)

    Schmid, Marc W; Grossniklaus, Ueli

    2015-02-01

    Analysis of differential gene expression by RNA sequencing (RNA-Seq) is frequently done using feature counts, i.e. the number of reads mapping to a gene. However, commonly used count algorithms (e.g. HTSeq) do not address the problem of reads aligning with multiple locations in the genome (multireads) or reads aligning with positions where two or more genes overlap (ambiguous reads). Rcount specifically addresses these issues. Furthermore, Rcount allows the user to assign priorities to certain feature types (e.g. higher priority for protein-coding genes compared to rRNA-coding genes) or to add flanking regions. Rcount provides a fast and easy-to-use graphical user interface requiring no command line or programming skills. It is implemented in C++ using the SeqAn (www.seqan.de) and the Qt libraries (qt-project.org). Source code and 64 bit binaries for (Ubuntu) Linux, Windows (7) and MacOSX are released under the GPLv3 license and are freely available on github.com/MWSchmid/Rcount. marcschmid@gmx.ch Test data, genome annotation files, useful Python and R scripts and a step-by-step user guide (including run-time and memory usage tests) are available on github.com/MWSchmid/Rcount. © The Author 2014. Published by Oxford University Press. All rights reserved. For Permissions, please e-mail: journals.permissions@oup.com.

  15. Seeking the perfect alignment

    CERN Multimedia

    2002-01-01

    The first full-scale tests of the ATLAS Muon Spectrometer are about to begin in Prévessin. The set-up includes several layers of Monitored Drift Tubes Chambers (MDTs) and will allow tests of the performance of the detectors and of their highly accurate alignment system.   Monitored Drift Chambers in Building 887 in Prévessin, where they are just about to be tested. Muon chambers are keeping the ATLAS Muon Spectrometer team quite busy this summer. Now that most people go on holiday, the beam and alignment tests for these chambers are just starting. These chambers will measure with high accuracy the momentum of high-energy muons, and this implies very demanding requirements for their alignment. The MDT chambers consist of drift tubes, which are gas-filled metal tubes, 3 cm in diameter, with wires running down their axes. With high voltage between the wire and the tube wall, the ionisation due to traversing muons is detected as electrical pulses. With careful timing of the pulses, the position of the muon t...

  16. ChromAlign: A two-step algorithmic procedure for time alignment of three-dimensional LC-MS chromatographic surfaces.

    Science.gov (United States)

    Sadygov, Rovshan G; Maroto, Fernando Martin; Hühmer, Andreas F R

    2006-12-15

    We present an algorithmic approach to align three-dimensional chromatographic surfaces of LC-MS data of complex mixture samples. The approach consists of two steps. In the first step, we prealign chromatographic profiles: two-dimensional projections of chromatographic surfaces. This is accomplished by correlation analysis using fast Fourier transforms. In this step, a temporal offset that maximizes the overlap and dot product between two chromatographic profiles is determined. In the second step, the algorithm generates correlation matrix elements between full mass scans of the reference and sample chromatographic surfaces. The temporal offset from the first step indicates a range of the mass scans that are possibly correlated, then the correlation matrix is calculated only for these mass scans. The correlation matrix carries information on highly correlated scans, but it does not itself determine the scan or time alignment. Alignment is determined as a path in the correlation matrix that maximizes the sum of the correlation matrix elements. The computational complexity of the optimal path generation problem is reduced by the use of dynamic programming. The program produces time-aligned surfaces. The use of the temporal offset from the first step in the second step reduces the computation time for generating the correlation matrix and speeds up the process. The algorithm has been implemented in a program, ChromAlign, developed in C++ language for the .NET2 environment in WINDOWS XP. In this work, we demonstrate the applications of ChromAlign to alignment of LC-MS surfaces of several datasets: a mixture of known proteins, samples from digests of surface proteins of T-cells, and samples prepared from digests of cerebrospinal fluid. ChromAlign accurately aligns the LC-MS surfaces we studied. In these examples, we discuss various aspects of the alignment by ChromAlign, such as constant time axis shifts and warping of chromatographic surfaces.

  17. Alignment Challenges for a Future Linear Collider

    CERN Document Server

    Durand, H; Stern, G

    2013-01-01

    The preservation of ultra-low emittances in the main linac and Beam Delivery System area is one of the main challenges for linear colliders. This requires alignment tolerances never achieved before at that scale, down to the micrometre level. As a matter of fact, in the LHC, the goal for the smoothing of the components was to obtain a 1σ deviation with respect to a smooth curve of 0.15 mm over a 150 m long sliding window, while for the CLIC project for example, it corresponds to 10 μm over a sliding window of 200 m in the Beam Delivery System area. Two complementary strategies are being studied to fulfil these requirements: the development and validation of long range alignment systems over a few hundreds of metres and short range alignment systems over a few metres. The studies undertaken, with associated tests setups and the latest results will be detailed, as well as their application for the alignment of both CLIC and ILC colliders.

  18. GPU-BSM: a GPU-based tool to map bisulfite-treated reads.

    Directory of Open Access Journals (Sweden)

    Andrea Manconi

    Full Text Available Cytosine DNA methylation is an epigenetic mark implicated in several biological processes. Bisulfite treatment of DNA is acknowledged as the gold standard technique to study methylation. This technique introduces changes in the genomic DNA by converting cytosines to uracils while 5-methylcytosines remain nonreactive. During PCR amplification 5-methylcytosines are amplified as cytosine, whereas uracils and thymines as thymine. To detect the methylation levels, reads treated with the bisulfite must be aligned against a reference genome. Mapping these reads to a reference genome represents a significant computational challenge mainly due to the increased search space and the loss of information introduced by the treatment. To deal with this computational challenge we devised GPU-BSM, a tool based on modern Graphics Processing Units. Graphics Processing Units are hardware accelerators that are increasingly being used successfully to accelerate general-purpose scientific applications. GPU-BSM is a tool able to map bisulfite-treated reads from whole genome bisulfite sequencing and reduced representation bisulfite sequencing, and to estimate methylation levels, with the goal of detecting methylation. Due to the massive parallelization obtained by exploiting graphics cards, GPU-BSM aligns bisulfite-treated reads faster than other cutting-edge solutions, while outperforming most of them in terms of unique mapped reads.

  19. Accurate genotyping across variant classes and lengths using variant graphs

    DEFF Research Database (Denmark)

    Sibbesen, Jonas Andreas; Maretty, Lasse; Jensen, Jacob Malte

    2018-01-01

    of read k-mers to a graph representation of the reference and variants to efficiently perform unbiased, probabilistic genotyping across the variation spectrum. We demonstrate that BayesTyper generally provides superior variant sensitivity and genotyping accuracy relative to existing methods when used...... collecting a set of candidate variants across discovery methods, individuals and databases, and then realigning the reads to the variants and reference simultaneously. However, this realignment problem has proved computationally difficult. Here, we present a new method (BayesTyper) that uses exact alignment...... to integrate variants across discovery approaches and individuals. Finally, we demonstrate that including a ‘variation-prior’ database containing already known variants significantly improves sensitivity....

  20. Location of long-period events below Kilauea Volcano using seismic amplitudes and accurate relative relocation

    Science.gov (United States)

    Battaglia, J.; Got, J.-L.; Okubo, P.

    2003-01-01

    We present methods for improving the location of long-period (LP) events, deep and shallow, recorded below Kilauea Volcano by the permanent seismic network. LP events might be of particular interest to understanding eruptive processes as their source mechanism is assumed to directly involve fluid transport. However, it is usually difficult or impossible to locate their source using traditional arrival time methods because of emergent wave arrivals. At Kilauea, similar LP waveform signatures suggest the existence of LP multiplets. The waveform similarity suggests spatially close sources, while catalog solutions using arrival time estimates are widely scattered beneath Kilauea's summit caldera. In order to improve estimates of absolute LP location, we use the distribution of seismic amplitudes corrected for station site effects. The decay of the amplitude as a function of hypocentral distance is used for inferring LP location. In a second stage, we use the similarity of the events to calculate their relative positions. The analysis of the entire LP seismicity recorded between January 1997 and December 1999 suggests that a very large part of the LP event population, both deep and shallow, is generated by a small number of compact sources. Deep events are systematically composed of a weak high-frequency onset followed by a low-frequency wave train. Aligning the low-frequency wave trains does not lead to aligning the onsets indicating the two parts of the signal are dissociated. This observation favors an interpretation in terms of triggering and resonance of a magmatic conduit. Instead of defining fault planes, the precise relocation of similar LP events, based on the alignment of the high-energy low-frequency wave trains, defines limited size volumes. Copyright 2003 by the American Geophysical Union.

  1. 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.

  2. Validation of the CLIC alignment strategy on short range

    CERN Document Server

    Mainaud Durand, H; Griffet, S; Kemppinen, J; Rude, V; Sosin, M

    2012-01-01

    The pre-alignment of CLIC consists of aligning the components of linacs and beam delivery systems (BDS) in the most accurate possible way, so that a first pilot beam can circulate and allow the implementation of the beam based alignment. Taking into account the precision and accuracy needed: 10 µm rms over sliding windows of 200m, this pre-alignment must be active and it can be divided into two parts: the determination of a straight reference over 20 km, thanks to a metrological network and the determination of the component positions with respect to this reference, and their adjustment. The second part is the object of the paper, describing the steps of the proposed strategy: firstly the fiducialisation of the different components of CLIC; secondly, the alignment of these components on common supports and thirdly the active alignment of these supports using sensors and actuators. These steps have been validated on a test setup over a length of 4m, and the obtained results are analysed.

  3. On the accuracy of short read mapping

    DEFF Research Database (Denmark)

    Menzel, Karl Peter; Frellsen, Jes; Plass, Mireya

    2013-01-01

    .e., mapping the reads to a reference genome. In this new situation, conventional alignment tools are obsolete, as they cannot handle this huge amount of data in a reasonable amount of time. Thus, new mapping algorithms have been developed, which are fast at the expense of a small decrease in accuracy...

  4. TotalReCaller: improved accuracy and performance via integrated alignment and base-calling.

    Science.gov (United States)

    Menges, Fabian; Narzisi, Giuseppe; Mishra, Bud

    2011-09-01

    Currently, re-sequencing approaches use multiple modules serially to interpret raw sequencing data from next-generation sequencing platforms, while remaining oblivious to the genomic information until the final alignment step. Such approaches fail to exploit the full information from both raw sequencing data and the reference genome that can yield better quality sequence reads, SNP-calls, variant detection, as well as an alignment at the best possible location in the reference genome. Thus, there is a need for novel reference-guided bioinformatics algorithms for interpreting analog signals representing sequences of the bases ({A, C, G, T}), while simultaneously aligning possible sequence reads to a source reference genome whenever available. Here, we propose a new base-calling algorithm, TotalReCaller, to achieve improved performance. A linear error model for the raw intensity data and Burrows-Wheeler transform (BWT) based alignment are combined utilizing a Bayesian score function, which is then globally optimized over all possible genomic locations using an efficient branch-and-bound approach. The algorithm has been implemented in soft- and hardware [field-programmable gate array (FPGA)] to achieve real-time performance. Empirical results on real high-throughput Illumina data were used to evaluate TotalReCaller's performance relative to its peers-Bustard, BayesCall, Ibis and Rolexa-based on several criteria, particularly those important in clinical and scientific applications. Namely, it was evaluated for (i) its base-calling speed and throughput, (ii) its read accuracy and (iii) its specificity and sensitivity in variant calling. A software implementation of TotalReCaller as well as additional information, is available at: http://bioinformatics.nyu.edu/wordpress/projects/totalrecaller/ fabian.menges@nyu.edu.

  5. TCS: a web server for multiple sequence alignment evaluation and phylogenetic reconstruction.

    Science.gov (United States)

    Chang, Jia-Ming; Di Tommaso, Paolo; Lefort, Vincent; Gascuel, Olivier; Notredame, Cedric

    2015-07-01

    This article introduces the Transitive Consistency Score (TCS) web server; a service making it possible to estimate the local reliability of protein multiple sequence alignments (MSAs) using the TCS index. The evaluation can be used to identify the aligned positions most likely to contain structurally analogous residues and also most likely to support an accurate phylogenetic reconstruction. The TCS scoring scheme has been shown to be accurate predictor of structural alignment correctness among commonly used methods. It has also been shown to outperform common filtering schemes like Gblocks or trimAl when doing MSA post-processing prior to phylogenetic tree reconstruction. The web server is available from http://tcoffee.crg.cat/tcs. © The Author(s) 2015. Published by Oxford University Press on behalf of Nucleic Acids Research.

  6. Reading problems and dyslexia : Identification, intervention and treatment within a RTI framework

    NARCIS (Netherlands)

    Scheltinga, F.

    2017-01-01

    This thesis focuses on the characteristics of reading problems and dyslexia and its treatment. Reading development and reading difficulties have drawn interest of many researchers. Accurate and fast word decoding is important for reading fluency and this in turn contributes to reading comprehension.

  7. STELLAR: fast and exact local alignments

    Directory of Open Access Journals (Sweden)

    Weese David

    2011-10-01

    Full Text Available Abstract Background Large-scale comparison of genomic sequences requires reliable tools for the search of local alignments. Practical local aligners are in general fast, but heuristic, and hence sometimes miss significant matches. Results We present here the local pairwise aligner STELLAR that has full sensitivity for ε-alignments, i.e. guarantees to report all local alignments of a given minimal length and maximal error rate. The aligner is composed of two steps, filtering and verification. We apply the SWIFT algorithm for lossless filtering, and have developed a new verification strategy that we prove to be exact. Our results on simulated and real genomic data confirm and quantify the conjecture that heuristic tools like BLAST or BLAT miss a large percentage of significant local alignments. Conclusions STELLAR is very practical and fast on very long sequences which makes it a suitable new tool for finding local alignments between genomic sequences under the edit distance model. Binaries are freely available for Linux, Windows, and Mac OS X at http://www.seqan.de/projects/stellar. The source code is freely distributed with the SeqAn C++ library version 1.3 and later at http://www.seqan.de.

  8. Absorber Alignment Measurement Tool for Solar Parabolic Trough Collectors: Preprint

    Energy Technology Data Exchange (ETDEWEB)

    Stynes, J. K.; Ihas, B.

    2012-04-01

    As we pursue efforts to lower the capital and installation costs of parabolic trough solar collectors, it is essential to maintain high optical performance. While there are many optical tools available to measure the reflector slope errors of parabolic trough solar collectors, there are few tools to measure the absorber alignment. A new method is presented here to measure the absorber alignment in two dimensions to within 0.5 cm. The absorber alignment is measured using a digital camera and four photogrammetric targets. Physical contact with the receiver absorber or glass is not necessary. The alignment of the absorber is measured along its full length so that sagging of the absorber can be quantified with this technique. The resulting absorber alignment measurement provides critical information required to accurately determine the intercept factor of a collector.

  9. JavaScript DNA translator: DNA-aligned protein translations.

    Science.gov (United States)

    Perry, William L

    2002-12-01

    There are many instances in molecular biology when it is necessary to identify ORFs in a DNA sequence. While programs exist for displaying protein translations in multiple ORFs in alignment with a DNA sequence, they are often expensive, exist as add-ons to software that must be purchased, or are only compatible with a particular operating system. JavaScript DNA Translator is a shareware application written in JavaScript, a scripting language interpreted by the Netscape Communicator and Internet Explorer Web browsers, which makes it compatible with several different operating systems. While the program uses a familiar Web page interface, it requires no connection to the Internet since calculations are performed on the user's own computer. The program analyzes one or multiple DNA sequences and generates translations in up to six reading frames aligned to a DNA sequence, in addition to displaying translations as separate sequences in FASTA format. ORFs within a reading frame can also be displayed as separate sequences. Flexible formatting options are provided, including the ability to hide ORFs below a minimum size specified by the user. The program is available free of charge at the BioTechniques Software Library (www.Biotechniques.com).

  10. Face Alignment via Regressing Local Binary Features.

    Science.gov (United States)

    Ren, Shaoqing; Cao, Xudong; Wei, Yichen; Sun, Jian

    2016-03-01

    This paper presents a highly efficient and accurate regression approach for face alignment. Our approach has two novel components: 1) a set of local binary features and 2) a locality principle for learning those features. The locality principle guides us to learn a set of highly discriminative local binary features for each facial landmark independently. The obtained local binary features are used to jointly learn a linear regression for the final output. This approach achieves the state-of-the-art results when tested on the most challenging benchmarks to date. Furthermore, because extracting and regressing local binary features are computationally very cheap, our system is much faster than previous methods. It achieves over 3000 frames per second (FPS) on a desktop or 300 FPS on a mobile phone for locating a few dozens of landmarks. We also study a key issue that is important but has received little attention in the previous research, which is the face detector used to initialize alignment. We investigate several face detectors and perform quantitative evaluation on how they affect alignment accuracy. We find that an alignment friendly detector can further greatly boost the accuracy of our alignment method, reducing the error up to 16% relatively. To facilitate practical usage of face detection/alignment methods, we also propose a convenient metric to measure how good a detector is for alignment initialization.

  11. Reading Ability and Memory Span: Long-Term Memory Contributions to Span for Good and Poor Readers.

    Science.gov (United States)

    McDougall, Sine J. P.; Donohoe, Rachael

    2002-01-01

    Investigates the extent to which differences in memory span for good and poor readers can be explained by differences in a long-term memory component to span as well as by differences in short-term memory processes. Discusses the nature of the interrelationships between memory span, reading and measures of phonological awareness. (SG)

  12. Alignment modification for pencil eye shields

    International Nuclear Information System (INIS)

    Evans, M.D.; Pla, M.; Podgorsak, E.B.

    1989-01-01

    Accurate alignment of pencil beam eye shields to protect the lens of the eye may be made easier by means of a simple modification of existing apparatus. This involves drilling a small hole through the center of the shield to isolate the rayline directed to the lens and fabricating a suitable plug for this hole

  13. Systematic evaluation of the impact of ChIP-seq read designs on genome coverage, peak identification, and allele-specific binding detection.

    Science.gov (United States)

    Zhang, Qi; Zeng, Xin; Younkin, Sam; Kawli, Trupti; Snyder, Michael P; Keleş, Sündüz

    2016-02-24

    Chromatin immunoprecipitation followed by sequencing (ChIP-seq) experiments revolutionized genome-wide profiling of transcription factors and histone modifications. Although maturing sequencing technologies allow these experiments to be carried out with short (36-50 bps), long (75-100 bps), single-end, or paired-end reads, the impact of these read parameters on the downstream data analysis are not well understood. In this paper, we evaluate the effects of different read parameters on genome sequence alignment, coverage of different classes of genomic features, peak identification, and allele-specific binding detection. We generated 101 bps paired-end ChIP-seq data for many transcription factors from human GM12878 and MCF7 cell lines. Systematic evaluations using in silico variations of these data as well as fully simulated data, revealed complex interplay between the sequencing parameters and analysis tools, and indicated clear advantages of paired-end designs in several aspects such as alignment accuracy, peak resolution, and most notably, allele-specific binding detection. Our work elucidates the effect of design on the downstream analysis and provides insights to investigators in deciding sequencing parameters in ChIP-seq experiments. We present the first systematic evaluation of the impact of ChIP-seq designs on allele-specific binding detection and highlights the power of pair-end designs in such studies.

  14. Aligning Metabolic Pathways Exploiting Binary Relation of Reactions.

    Directory of Open Access Journals (Sweden)

    Yiran Huang

    Full Text Available Metabolic pathway alignment has been widely used to find one-to-one and/or one-to-many reaction mappings to identify the alternative pathways that have similar functions through different sets of reactions, which has important applications in reconstructing phylogeny and understanding metabolic functions. The existing alignment methods exhaustively search reaction sets, which may become infeasible for large pathways. To address this problem, we present an effective alignment method for accurately extracting reaction mappings between two metabolic pathways. We show that connected relation between reactions can be formalized as binary relation of reactions in metabolic pathways, and the multiplications of zero-one matrices for binary relations of reactions can be accomplished in finite steps. By utilizing the multiplications of zero-one matrices for binary relation of reactions, we efficiently obtain reaction sets in a small number of steps without exhaustive search, and accurately uncover biologically relevant reaction mappings. Furthermore, we introduce a measure of topological similarity of nodes (reactions by comparing the structural similarity of the k-neighborhood subgraphs of the nodes in aligning metabolic pathways. We employ this similarity metric to improve the accuracy of the alignments. The experimental results on the KEGG database show that when compared with other state-of-the-art methods, in most cases, our method obtains better performance in the node correctness and edge correctness, and the number of the edges of the largest common connected subgraph for one-to-one reaction mappings, and the number of correct one-to-many reaction mappings. Our method is scalable in finding more reaction mappings with better biological relevance in large metabolic pathways.

  15. Italian Children with Dyslexia Are Also Poor in Reading English Words, but Accurate in Reading English Pseudowords

    Science.gov (United States)

    Palladino, Paola; Bellagamba, Isabella; Ferrari, Marcella; Cornoldi, Cesare

    2013-01-01

    It has been argued that children with dyslexia (DC) are poor at learning a foreign language (L2) and, in particular, reading foreign words. This assumption is so general that an Italian law (law 170, October, 2010) has established that DC may be completely exempted from foreign language learning and, in any case, should not be engaged in tuition…

  16. MANGO: a new approach to multiple sequence alignment.

    Science.gov (United States)

    Zhang, Zefeng; Lin, Hao; Li, Ming

    2007-01-01

    Multiple sequence alignment is a classical and challenging task for biological sequence analysis. The problem is NP-hard. The full dynamic programming takes too much time. The progressive alignment heuristics adopted by most state of the art multiple sequence alignment programs suffer from the 'once a gap, always a gap' phenomenon. Is there a radically new way to do multiple sequence alignment? This paper introduces a novel and orthogonal multiple sequence alignment method, using multiple optimized spaced seeds and new algorithms to handle these seeds efficiently. Our new algorithm processes information of all sequences as a whole, avoiding problems caused by the popular progressive approaches. Because the optimized spaced seeds are provably significantly more sensitive than the consecutive k-mers, the new approach promises to be more accurate and reliable. To validate our new approach, we have implemented MANGO: Multiple Alignment with N Gapped Oligos. Experiments were carried out on large 16S RNA benchmarks showing that MANGO compares favorably, in both accuracy and speed, against state-of-art multiple sequence alignment methods, including ClustalW 1.83, MUSCLE 3.6, MAFFT 5.861, Prob-ConsRNA 1.11, Dialign 2.2.1, DIALIGN-T 0.2.1, T-Coffee 4.85, POA 2.0 and Kalign 2.0.

  17. An Adaptive Hybrid Multiprocessor technique for bioinformatics sequence alignment

    KAUST Repository

    Bonny, Talal; Salama, Khaled N.; Zidan, Mohammed A.

    2012-01-01

    Sequence alignment algorithms such as the Smith-Waterman algorithm are among the most important applications in the development of bioinformatics. Sequence alignment algorithms must process large amounts of data which may take a long time. Here, we

  18. Automated and Adaptable Quantification of Cellular Alignment from Microscopic Images for Tissue Engineering Applications

    Science.gov (United States)

    Xu, Feng; Beyazoglu, Turker; Hefner, Evan; Gurkan, Umut Atakan

    2011-01-01

    Cellular alignment plays a critical role in functional, physical, and biological characteristics of many tissue types, such as muscle, tendon, nerve, and cornea. Current efforts toward regeneration of these tissues include replicating the cellular microenvironment by developing biomaterials that facilitate cellular alignment. To assess the functional effectiveness of the engineered microenvironments, one essential criterion is quantification of cellular alignment. Therefore, there is a need for rapid, accurate, and adaptable methodologies to quantify cellular alignment for tissue engineering applications. To address this need, we developed an automated method, binarization-based extraction of alignment score (BEAS), to determine cell orientation distribution in a wide variety of microscopic images. This method combines a sequenced application of median and band-pass filters, locally adaptive thresholding approaches and image processing techniques. Cellular alignment score is obtained by applying a robust scoring algorithm to the orientation distribution. We validated the BEAS method by comparing the results with the existing approaches reported in literature (i.e., manual, radial fast Fourier transform-radial sum, and gradient based approaches). Validation results indicated that the BEAS method resulted in statistically comparable alignment scores with the manual method (coefficient of determination R2=0.92). Therefore, the BEAS method introduced in this study could enable accurate, convenient, and adaptable evaluation of engineered tissue constructs and biomaterials in terms of cellular alignment and organization. PMID:21370940

  19. The oceanic literary reading mind : An impression

    NARCIS (Netherlands)

    Burke, M.

    2016-01-01

    The mind and brain processes of the literary reading mind are most accurately defined as oceanic: the mind is an ocean. This is the essential premise that I put forward in my book Literary Reading, Cognition and Emotion: An Exploration of the Oceanic Mind (Routledge, 2011).1 The statement is of

  20. Vacuum mechatronic laser alignment system on the Nova laser

    International Nuclear Information System (INIS)

    Holliday, M.; Wong, K.; Shelton, R.

    1991-11-01

    The experiments conducted on NOVA are done to investigate inertially confined laser fusion reactions. To this end, the ten beams of the laser are aligned to within 30mm. The target chamber employs a vacuum mechatronic based reticle/target positioning system to accomplish this. It is a five degree-of-freedom chamber resident system, known as the Alignment Aids Positioner or AAP. The AAP aids in beam and diagnostic alignment by accurately positioning a reticle at target chamber center to with 7mm. The AAP system increases target positioning and alignment flexibility and accuracy through the use of a computer controlled multi degree-of-freedom stage assembly. This device uses microstepping DC stepper motors with encoders to achieve closed loop control in a 10 -6 torr vacuum. The AAP has two positioning regimes to move the alignment reticle and do beam alignment. One is course positioning in the Y-Z plane that moves a high resolution stage assembly to target chamber center. The other regime is high resolution movement in the X,Y,Z and q directions. 5 refs., 9 figs

  1. Parallel versus Sequential Processing in Print and Braille Reading

    Science.gov (United States)

    Veispak, Anneli; Boets, Bart; Ghesquiere, Pol

    2012-01-01

    In the current study we investigated word, pseudoword and story reading in Dutch speaking braille and print readers. To examine developmental patterns, these reading skills were assessed in both children and adults. The results reveal that braille readers read less accurately and fast than print readers. While item length has no impact on word…

  2. PROMOTING AUTONOMOUS LEARNING IN READING CLASS

    Directory of Open Access Journals (Sweden)

    Agus Sholeh

    2015-11-01

    Full Text Available To have good acquisition and awareness in reading, the learners need a long and continuous process, and therefore, they are required to have autonomy in learning reading. This study aims to promote learner autonomy in reading class by combining learner-centered reading teaching and extensive reading teaching. Learner-centered reading teaching was carried out through group discussion, presentation, and language awareness activities. Meanwhile, extensive reading teaching was done to review the learners‘ materials in presentation and reinforce their acquisition. Those two different approaches were applied due to differences on learner's characteristics and needs. The result showed some success in the practice of autonomy, indicated by changes on learners' attitude. However, many learners showed that they focused more on obtaining score than on developing their language acquisition. By implementing the approach, the teacher can assist learners to be aware of their ability to learn independently and equip them with the skill needed for long-life learning.

  3. Mango: multiple alignment with N gapped oligos.

    Science.gov (United States)

    Zhang, Zefeng; Lin, Hao; Li, Ming

    2008-06-01

    Multiple sequence alignment is a classical and challenging task. The problem is NP-hard. The full dynamic programming takes too much time. The progressive alignment heuristics adopted by most state-of-the-art works suffer from the "once a gap, always a gap" phenomenon. Is there a radically new way to do multiple sequence alignment? In this paper, we introduce a novel and orthogonal multiple sequence alignment method, using both multiple optimized spaced seeds and new algorithms to handle these seeds efficiently. Our new algorithm processes information of all sequences as a whole and tries to build the alignment vertically, avoiding problems caused by the popular progressive approaches. Because the optimized spaced seeds have proved significantly more sensitive than the consecutive k-mers, the new approach promises to be more accurate and reliable. To validate our new approach, we have implemented MANGO: Multiple Alignment with N Gapped Oligos. Experiments were carried out on large 16S RNA benchmarks, showing that MANGO compares favorably, in both accuracy and speed, against state-of-the-art multiple sequence alignment methods, including ClustalW 1.83, MUSCLE 3.6, MAFFT 5.861, ProbConsRNA 1.11, Dialign 2.2.1, DIALIGN-T 0.2.1, T-Coffee 4.85, POA 2.0, and Kalign 2.0. We have further demonstrated the scalability of MANGO on very large datasets of repeat elements. MANGO can be downloaded at http://www.bioinfo.org.cn/mango/ and is free for academic usage.

  4. Robust image alignment for cryogenic transmission electron microscopy.

    Science.gov (United States)

    McLeod, Robert A; Kowal, Julia; Ringler, Philippe; Stahlberg, Henning

    2017-03-01

    Cryo-electron microscopy recently experienced great improvements in structure resolution due to direct electron detectors with improved contrast and fast read-out leading to single electron counting. High frames rates enabled dose fractionation, where a long exposure is broken into a movie, permitting specimen drift to be registered and corrected. The typical approach for image registration, with high shot noise and low contrast, is multi-reference (MR) cross-correlation. Here we present the software package Zorro, which provides robust drift correction for dose fractionation by use of an intensity-normalized cross-correlation and logistic noise model to weight each cross-correlation in the MR model and filter each cross-correlation optimally. Frames are reliably registered by Zorro with low dose and defocus. Methods to evaluate performance are presented, by use of independently-evaluated even- and odd-frame stacks by trajectory comparison and Fourier ring correlation. Alignment of tiled sub-frames is also introduced, and demonstrated on an example dataset. Zorro source code is available at github.com/CINA/zorro. Copyright © 2016 Elsevier Inc. All rights reserved.

  5. Ligand Binding Site Detection by Local Structure Alignment and Its Performance Complementarity

    Science.gov (United States)

    Lee, Hui Sun; Im, Wonpil

    2013-01-01

    Accurate determination of potential ligand binding sites (BS) is a key step for protein function characterization and structure-based drug design. Despite promising results of template-based BS prediction methods using global structure alignment (GSA), there is a room to improve the performance by properly incorporating local structure alignment (LSA) because BS are local structures and often similar for proteins with dissimilar global folds. We present a template-based ligand BS prediction method using G-LoSA, our LSA tool. A large benchmark set validation shows that G-LoSA predicts drug-like ligands’ positions in single-chain protein targets more precisely than TM-align, a GSA-based method, while the overall success rate of TM-align is better. G-LoSA is particularly efficient for accurate detection of local structures conserved across proteins with diverse global topologies. Recognizing the performance complementarity of G-LoSA to TM-align and a non-template geometry-based method, fpocket, a robust consensus scoring method, CMCS-BSP (Complementary Methods and Consensus Scoring for ligand Binding Site Prediction), is developed and shows improvement on prediction accuracy. The G-LoSA source code is freely available at http://im.bioinformatics.ku.edu/GLoSA. PMID:23957286

  6. Novice Teachers' Knowledge of Reading-Related Disabilities and Dyslexia

    Science.gov (United States)

    Washburn, Erin K.; Mulcahy, Candance A.; Musante, Gail; Joshi, R. Malatesha

    2017-01-01

    Current understandings about the nature of persistent reading problems have been influenced by researchers in numerous fields. Researchers have noted that a current and accurate understanding of reading disabilities, such as dyslexia, can be helpful in assessing, teaching and supporting individuals with persistent reading problems. The purpose of…

  7. Proper construction of ab initio global potential surfaces with accurate long-range interactions

    International Nuclear Information System (INIS)

    Ho, Tak-San; Rabitz, Herschel

    2000-01-01

    An efficient procedure based on the reproducing kernel Hilbert space interpolation method is presented for constructing intermolecular potential energy surfaces (PES) using not only calculated ab initio data but also a priori information on long-range interactions. Explicitly, use of the reciprocal power reproducing kernel on the semiinfinite interval [0,∞) yields a set of exact linear relations between dispersion (multipolar) coefficients and PES data points at finite internuclear separations. Consequently, given a combined set of ab initio data and the values of dispersion (multipolar) coefficients, the potential interpolation problem subject to long-range interaction constraints can be solved to render globally smooth, asymptotically accurate ab initio potential energy surfaces. Very good results have been obtained for the one-dimensional He-He potential curve and the two-dimensional Ne-CO PES. The construction of the Ne-CO PES was facilitated by invoking a new reproducing kernel for the angular coordinate based on the optimally stable and shape-preserving Bernstein basis functions. (c) 2000 American Institute of Physics

  8. Read-only high accuracy volume holographic optical correlator

    Science.gov (United States)

    Zhao, Tian; Li, Jingming; Cao, Liangcai; He, Qingsheng; Jin, Guofan

    2011-10-01

    A read-only volume holographic correlator (VHC) is proposed. After the recording of all of the correlation database pages by angular multiplexing, a stand-alone read-only high accuracy VHC will be separated from the VHC recording facilities which include the high-power laser and the angular multiplexing system. The stand-alone VHC has its own low power readout laser and very compact and simple structure. Since there are two lasers that are employed for recording and readout, respectively, the optical alignment tolerance of the laser illumination on the SLM is very sensitive. The twodimensional angular tolerance is analyzed based on the theoretical model of the volume holographic correlator. The experimental demonstration of the proposed read-only VHC is introduced and discussed.

  9. Beam based alignment at the KEK accelerator test facility

    International Nuclear Information System (INIS)

    Ross, M.; Nelson, J.; Woodley, M.; Wolski, A.

    2002-01-01

    The KEK Accelerator Test Facility (ATF) damping ring is a prototype low emittance source for the NLC/JLC linear collider. To achieve the goal normalized vertical emittance gey = 20 nm-rad, magnet placement accuracy better than 30 mm must be achieved. Accurate beam-based alignment (BBA) is required. The ATF arc optics uses a FOBO cell with two horizontally focusing quadrupoles, two sextupoles and a horizontally defocusing gradient dipole, all of which must be aligned with BBA. BBA at ATF uses the quadrupole and sextupole trim windings to find the trajectory through the center of each magnet. The results can be interpreted to assess the accuracy of the mechanical alignment and the beam position monitor offsets

  10. Crowdsourcing RNA structural alignments with an online computer game.

    Science.gov (United States)

    Waldispühl, Jérôme; Kam, Arthur; Gardner, Paul P

    2015-01-01

    The annotation and classification of ncRNAs is essential to decipher molecular mechanisms of gene regulation in normal and disease states. A database such as Rfam maintains alignments, consensus secondary structures, and corresponding annotations for RNA families. Its primary purpose is the automated, accurate annotation of non-coding RNAs in genomic sequences. However, the alignment of RNAs is computationally challenging, and the data stored in this database are often subject to improvements. Here, we design and evaluate Ribo, a human-computing game that aims to improve the accuracy of RNA alignments already stored in Rfam. We demonstrate the potential of our techniques and discuss the feasibility of large scale collaborative annotation and classification of RNA families.

  11. LocARNA-P: Accurate boundary prediction and improved detection of structural RNAs

    DEFF Research Database (Denmark)

    Will, Sebastian; Joshi, Tejal; Hofacker, Ivo L.

    2012-01-01

    Current genomic screens for noncoding RNAs (ncRNAs) predict a large number of genomic regions containing potential structural ncRNAs. The analysis of these data requires highly accurate prediction of ncRNA boundaries and discrimination of promising candidate ncRNAs from weak predictions. Existing...... methods struggle with these goals because they rely on sequence-based multiple sequence alignments, which regularly misalign RNA structure and therefore do not support identification of structural similarities. To overcome this limitation, we compute columnwise and global reliabilities of alignments based...... on sequence and structure similarity; we refer to these structure-based alignment reliabilities as STARs. The columnwise STARs of alignments, or STAR profiles, provide a versatile tool for the manual and automatic analysis of ncRNAs. In particular, we improve the boundary prediction of the widely used nc...

  12. Capillary self-alignment of mesoscopic foil components for sensor-systems-in-foil

    International Nuclear Information System (INIS)

    Arutinov, Gari; Smits, Edsger C P; Van Heck, Gert; Van den Brand, Jeroen; Schoo, Herman F M; Mastrangeli, Massimo; Dietzel, Andreas

    2012-01-01

    This paper reports on the effective use of capillary self-alignment for low-cost and time-efficient assembly of heterogeneous foil components into a smart electronic identification label. Particularly, we demonstrate the accurate (better than 50 µm) alignment of cm-sized functional foil dies. We investigated the role played by the assembly liquid, by the size and the weight of assembling dies and by their initial offsets in the self-alignment performance. It was shown that there is a definite range of initial offsets allowing dies to align with high accuracy and within approximately the same time window, irrespective of their initial offset. (paper)

  13. 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.

  14. Advanced Alignment of the ATLAS Inner Detector

    CERN Document Server

    Stahlman, JM; The ATLAS collaboration

    2012-01-01

    The primary goal of the ATLAS Inner Detector (ID) is to measure the trajectories of charged particles in the high particle density environment of the Large Hadron Collider (LHC) collisions. This is achieved using a combination of different technologies, including silicon pixels, silicon microstrips, and gaseous drift-tubes, all immersed in a 2 Tesla magnetic field. With over one million alignable degrees of freedom, it is crucial that an accurate model of the detector positions be produced using an automated and robust algorithm in order to achieve good tracking performance. This has been accomplished using a variety of alignment techniques resulting in near optimal hit and momentum resolutions.

  15. Flexible taxonomic assignment of ambiguous sequencing reads

    Directory of Open Access Journals (Sweden)

    Jansson Jesper

    2011-01-01

    Full Text Available Abstract Background To characterize the diversity of bacterial populations in metagenomic studies, sequencing reads need to be accurately assigned to taxonomic units in a given reference taxonomy. Reads that cannot be reliably assigned to a unique leaf in the taxonomy (ambiguous reads are typically assigned to the lowest common ancestor of the set of species that match it. This introduces a potentially severe error in the estimation of bacteria present in the sample due to false positives, since all species in the subtree rooted at the ancestor are implicitly assigned to the read even though many of them may not match it. Results We present a method that maps each read to a node in the taxonomy that minimizes a penalty score while balancing the relevance of precision and recall in the assignment through a parameter q. This mapping can be obtained in time linear in the number of matching sequences, because LCA queries to the reference taxonomy take constant time. When applied to six different metagenomic datasets, our algorithm produces different taxonomic distributions depending on whether coverage or precision is maximized. Including information on the quality of the reads reduces the number of unassigned reads but increases the number of ambiguous reads, stressing the relevance of our method. Finally, two measures of performance are described and results with a set of artificially generated datasets are discussed. Conclusions The assignment strategy of sequencing reads introduced in this paper is a versatile and a quick method to study bacterial communities. The bacterial composition of the analyzed samples can vary significantly depending on how ambiguous reads are assigned depending on the value of the q parameter. Validation of our results in an artificial dataset confirm that a combination of values of q produces the most accurate results.

  16. 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

  17. 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

  18. Alignment and orientation in ion/endash/atom collisions

    International Nuclear Information System (INIS)

    Kimura, M.; Lane, N.F.

    1987-01-01

    Recent progress in the theoretical study of alignment and orientation in atom-atom and ion-atom collisions at intermediate energies is reviewed. Recent systematic studies of the alignment and orientation of electronic charge cloud distributions of excited states resulting from such collisions clearly have provided more detailed information about the underlying collision dynamics. However, since accurate determination of these parameters is quite difficult, both theoretically and experimentally, a close collaboration between theory and experiment is necessary for a deeper understanding of the collision dynamics. A more complete approach, where the full density matrix is determined, is also discussed

  19. CMS Muon Alignment: System Description and first results

    CERN Document Server

    Sobron, M

    2008-01-01

    The CMS detector has been instrumented with a precise and complex opto-mechanical alignment subsystem that provides a common reference frame between Tracker and Muon detection systems by means of a net of laser beams. The system allows a continuous and accurate monitoring of the muon chambers positions with respect to the Tracker body. Preliminary results of operation during the test of the CMS 4T solenoid magnet, performed in 2006, are presented. These measurements complement the information provided by the use of survey techniques and the results of alignment algorithms based on muon tracks crossing the detector.

  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. Accurate typing of short tandem repeats from genome-wide sequencing data and its applications.

    Science.gov (United States)

    Fungtammasan, Arkarachai; Ananda, Guruprasad; Hile, Suzanne E; Su, Marcia Shu-Wei; Sun, Chen; Harris, Robert; Medvedev, Paul; Eckert, Kristin; Makova, Kateryna D

    2015-05-01

    Short tandem repeats (STRs) are implicated in dozens of human genetic diseases and contribute significantly to genome variation and instability. Yet profiling STRs from short-read sequencing data is challenging because of their high sequencing error rates. Here, we developed STR-FM, short tandem repeat profiling using flank-based mapping, a computational pipeline that can detect the full spectrum of STR alleles from short-read data, can adapt to emerging read-mapping algorithms, and can be applied to heterogeneous genetic samples (e.g., tumors, viruses, and genomes of organelles). We used STR-FM to study STR error rates and patterns in publicly available human and in-house generated ultradeep plasmid sequencing data sets. We discovered that STRs sequenced with a PCR-free protocol have up to ninefold fewer errors than those sequenced with a PCR-containing protocol. We constructed an error correction model for genotyping STRs that can distinguish heterozygous alleles containing STRs with consecutive repeat numbers. Applying our model and pipeline to Illumina sequencing data with 100-bp reads, we could confidently genotype several disease-related long trinucleotide STRs. Utilizing this pipeline, for the first time we determined the genome-wide STR germline mutation rate from a deeply sequenced human pedigree. Additionally, we built a tool that recommends minimal sequencing depth for accurate STR genotyping, depending on repeat length and sequencing read length. The required read depth increases with STR length and is lower for a PCR-free protocol. This suite of tools addresses the pressing challenges surrounding STR genotyping, and thus is of wide interest to researchers investigating disease-related STRs and STR evolution. © 2015 Fungtammasan et al.; Published by Cold Spring Harbor Laboratory Press.

  2. Alignment at the ESRF

    International Nuclear Information System (INIS)

    Martin, D.; Levet, N.; Gatta, G.

    1999-01-01

    The ESRF Survey and Alignment group is responsible for the installation, control and periodic realignment of the accelerators and experiments which produce high quality x-rays used by scientists from Europe and around the world. Alignment tolerances are typically less than one millimetre and often in the order of several micrometers. The group is composed of one engineer, five highly trained survey technicians, one electronic and one computer technician. This team is fortified during peak periods by technicians from an external survey company. First an overview and comparative study of the main large-scale survey instrumentation and methods used by the group is made. Secondly a discussion of long term deformation on the ESRF site is presented. This is followed by presentation of the methods used in the realignment of the various machines. Two important aspects of our work, beamline and front-end alignment, and the so-called machine exotic devices are briefly discussed. Finally, the ESRF calibration bench is presented. (authors)

  3. 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.

  4. MALINA: a web service for visual analytics of human gut microbiota whole-genome metagenomic reads.

    Science.gov (United States)

    Tyakht, Alexander V; Popenko, Anna S; Belenikin, Maxim S; Altukhov, Ilya A; Pavlenko, Alexander V; Kostryukova, Elena S; Selezneva, Oksana V; Larin, Andrei K; Karpova, Irina Y; Alexeev, Dmitry G

    2012-12-07

    MALINA is a web service for bioinformatic analysis of whole-genome metagenomic data obtained from human gut microbiota sequencing. As input data, it accepts metagenomic reads of various sequencing technologies, including long reads (such as Sanger and 454 sequencing) and next-generation (including SOLiD and Illumina). It is the first metagenomic web service that is capable of processing SOLiD color-space reads, to authors' knowledge. The web service allows phylogenetic and functional profiling of metagenomic samples using coverage depth resulting from the alignment of the reads to the catalogue of reference sequences which are built into the pipeline and contain prevalent microbial genomes and genes of human gut microbiota. The obtained metagenomic composition vectors are processed by the statistical analysis and visualization module containing methods for clustering, dimension reduction and group comparison. Additionally, the MALINA database includes vectors of bacterial and functional composition for human gut microbiota samples from a large number of existing studies allowing their comparative analysis together with user samples, namely datasets from Russian Metagenome project, MetaHIT and Human Microbiome Project (downloaded from http://hmpdacc.org). MALINA is made freely available on the web at http://malina.metagenome.ru. The website is implemented in JavaScript (using Ext JS), Microsoft .NET Framework, MS SQL, Python, with all major browsers supported.

  5. A highly accurate positioning and orientation system based on the usage of four-cluster fibre optic gyros

    International Nuclear Information System (INIS)

    Zhang, Xiaoyue; Lin, Zhili; Zhang, Chunxi

    2013-01-01

    A highly accurate positioning and orientation technique based on four-cluster fibre optic gyros (FOGs) is presented. The four-cluster FOG inertial measurement unit (IMU) comprises three low-precision FOGs, one static high-precision FOG and three accelerometers. To realize high-precision positioning and orientation, the static alignment (north-seeking) before vehicle manoeuvre was divided into a low-precision self-alignment phase and a high-precision north-seeking (online calibration) phase. The high-precision FOG measurement information was introduced to obtain high-precision azimuth alignment (north-seeking) result and achieve online calibration of the low-precision three-cluster FOG. The results of semi-physical simulation were presented to validate the availability and utility of the highly accurate positioning and orientation technique based on the four-cluster FOGs. (paper)

  6. Alignment for new Subaru ring

    International Nuclear Information System (INIS)

    Zhang, Ch.; Matsui, S.; Hashimoto, S.

    1999-01-01

    The New SUBARU is a synchrotron light source being constructed at the SPring-8 site. The main facility is a 1.5 GeV electron storage ring that provides light beam in the region from VUV to soft X-ray using SPring-8's 1 GeV linac as an injector. The ring, with a circumference of about 119 meters, is composed of six bending cells. Each bending cell has two normal dipoles of 34 degree and one inverse dipole of -8 degree. The ring has six straight sections: two very long straight sections for a 11-m long undulator and an optical klystron, four short straight sections for a 2.3-m undulator, a super-conducting wiggler, rf cavity and injection, etc. The magnets of the storage ring are composed of 12 dipoles (BMs), 6 invert dipoles (BIs), 56 quadrupoles and 44 sextupoles, etc. For the magnet alignment, positions of the dipoles (the BMs and BIs) are determined by network survey method. The multipoles, which are mounted on girders between the dipoles, are aligned with a laser-CCD camera system. This article presents the methodology used to position the different components and particularly to assure the precise alignment of the multipoles. (authors)

  7. Emerging applications of read profiles towards the functional annotation of the genome

    DEFF Research Database (Denmark)

    Pundhir, Sachin; Poirazi, Panayiota; Gorodkin, Jan

    2015-01-01

    is typically a result of the protocol designed to address specific research questions. The sequencing results in reads, which when mapped to a reference genome often leads to the formation of distinct patterns (read profiles). Interpretation of these read profiles is essential for their analysis in relation...... to the research question addressed. Several strategies have been employed at varying levels of abstraction ranging from a somewhat ad hoc to a more systematic analysis of read profiles. These include methods which can compare read profiles, e.g., from direct (non-sequence based) alignments to classification...... of patterns into functional groups. In this review, we highlight the emerging applications of read profiles for the annotation of non-coding RNA and cis-regulatory elements (CREs) such as enhancers and promoters. We also discuss the biological rationale behind their formation....

  8. Expanding the catalog of binary black-hole simulations: aligned-spin configurations

    Science.gov (United States)

    Chu, Tony; Pfeiffer, Harald; Scheel, Mark; Szilagyi, Bela; SXS Collaboration

    2015-04-01

    A major goal of numerical relativity is to model the inspiral and merger of binary black holes through sufficiently accurate and long simulations, to enable the successful detection of gravitational waves. However, covering the full parameter space of binary configurations is a computationally daunting task. The SXS Collaboration has made important progress in this direction recently, with a catalog of 174 publicly available binary black-hole simulations [black-holes.org/waveforms]. Nevertheless, the parameter-space coverage remains sparse, even for non-precessing binaries. In this talk, I will describe an addition to the SXS catalog to improve its coverage, consisting of 95 new simulations of aligned-spin binaries with moderate mass ratios and dimensionless spins as high as 0.9. Some applications of these new simulations will also be mentioned.

  9. Identification of children with reading difficulties: Cheap can be adequate

    DEFF Research Database (Denmark)

    Poulsen, Mads; Nielsen, Anne-Mette Veber

    Classification of reading difficulties: Cheap screening can be accurate Purpose: Three factors are important for identification of students in need of remedial instruction: accuracy, timeliness, and cost. The identification has to be accurate to be of any use, the identification has to be timely......, inexpensive testing. The present study investigated the classification accuracy of three screening models varying in timeliness and cost. Method: We compared the ROC statistics of three logistic models for predicting end of Grade 2 reading difficulties in a sample of 164 students: 1) an early, comprehensive...... model using a battery of Grade 0 tests, including phoneme awareness, rapid naming, and paired associate learning, 2) a late, comprehensive model adding reading measures from January of Grade 1, and 3) a late, inexpensive model using only group-administered reading measures from January of Grade 1...

  10. Alignment of the VISA Undulator

    International Nuclear Information System (INIS)

    Ruland, Robert E.

    2000-01-01

    As part of the R and D program towards a fourth generation light source, a Self-Amplified Spontaneous Emission (SASE) demonstration is being prepared. The Visible-Infrared SASE Amplifier (VISA) undulator is being installed at Brookhaven National Laboratory. The VISA undulator is an in-vacuum, 4-meter long, 1.8 cm period, pure-permanent magnet device, with a novel, strong focusing, permanent magnet FODO array included within the fixed, 6 mm undulator gap. The undulator is constructed of 99 cm long segments. To attain maximum SASE gain requires establishing overlap of electron and photon beams to within 50 pm rms. This imposes challenging tolerances on mechanical fabrication and magnetic field quality, and necessitates use of laser straightness interferometry for calibration and alignment of the magnetic axes of the undulator segments. This paper describes the magnetic centerline determination, and the fiducialization and alignment processes, which were performed to meet the tolerance goal

  11. A short note on dynamic programming in a band.

    Science.gov (United States)

    Gibrat, Jean-François

    2018-06-15

    Third generation sequencing technologies generate long reads that exhibit high error rates, in particular for insertions and deletions which are usually the most difficult errors to cope with. The only exact algorithm capable of aligning sequences with insertions and deletions is a dynamic programming algorithm. In this note, for the sake of efficiency, we consider dynamic programming in a band. We show how to choose the band width in function of the long reads' error rates, thus obtaining an [Formula: see text] algorithm in space and time. We also propose a procedure to decide whether this algorithm, when applied to semi-global alignments, provides the optimal score. We suggest that dynamic programming in a band is well suited to the problem of aligning long reads between themselves and can be used as a core component of methods for obtaining a consensus sequence from the long reads alone. The function implementing the dynamic programming algorithm in a band is available, as a standalone program, at: https://forgemia.inra.fr/jean-francois.gibrat/BAND_DYN_PROG.git.

  12. Control rod housing alignment and repair method

    International Nuclear Information System (INIS)

    Dixon, R.C.; Deaver, G.A.; Punches, J.R.; Singleton, G.E.; Erbes, J.G.; Offer, H.P.

    1992-01-01

    This patent describes a method for underwater welding of a control rod drive housing inserted through a stub tube to maintain requisite alignment and elevation of the top of the control rod drive housing to an overlying and corresponding aperture in a core plate as measured by an alignment device which determines the relative elevation and angularity with respect to the aperture. It comprises providing a welding cylinder dependent from the alignment device such that the elevation of the top of the welding cylinder is in a fixed relationship to the alignment device and is gas-proof; pressurizing the welding cylinder with inert welding gas sufficient to maintain the interior of the welding cylinder dry; lowering the welding cylinder through the aperture in the core plate by depending the cylinder with respect to the alignment device, the lowering including lowering through and adjusting the elevation relationship of the welding cylinder to the alignment device such that when the alignment device is in position to measure the elevation and angularity of the new control rod drive housing, the lower distal end of the welding cylinder extends below the upper periphery of the stub where welding is to occur; inserting a new control rod drive housing through the stub tube and positioning the control rod drive housing to a predetermined relationship to the anticipated final position of the control rod drive housing; providing welding implements transversely rotatably mounted interior of the welding cylinder relative to the alignment device such that the welding implements may be accurately positioned for dispensing weldment around the periphery of the top of the stub tube and at the side of the control rod drive housing; measuring the elevation and angularity of the control rod drive housing; and dispensing weldment along the top of the stub tube and at the side of the control rod drive housing

  13. A transcriptome atlas of rabbit revealed by PacBio single-molecule long-read sequencing.

    Science.gov (United States)

    Chen, Shi-Yi; Deng, Feilong; Jia, Xianbo; Li, Cao; Lai, Song-Jia

    2017-08-09

    It is widely acknowledged that transcriptional diversity largely contributes to biological regulation in eukaryotes. Since the advent of second-generation sequencing technologies, a large number of RNA sequencing studies have considerably improved our understanding of transcriptome complexity. However, it still remains a huge challenge for obtaining full-length transcripts because of difficulties in the short read-based assembly. In the present study we employ PacBio single-molecule long-read sequencing technology for whole-transcriptome profiling in rabbit (Oryctolagus cuniculus). We totally obtain 36,186 high-confidence transcripts from 14,474 genic loci, among which more than 23% of genic loci and 66% of isoforms have not been annotated yet within the current reference genome. Furthermore, about 17% of transcripts are computationally revealed to be non-coding RNAs. Up to 24,797 alternative splicing (AS) and 11,184 alternative polyadenylation (APA) events are detected within this de novo constructed transcriptome, respectively. The results provide a comprehensive set of reference transcripts and hence contribute to the improved annotation of rabbit genome.

  14. 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

  15. Note: long range and accurate measurement of deep trench microstructures by a specialized scanning tunneling microscope.

    Science.gov (United States)

    Ju, Bing-Feng; Chen, Yuan-Liu; Zhang, Wei; Zhu, Wule; Jin, Chao; Fang, F Z

    2012-05-01

    A compact but practical scanning tunneling microscope (STM) with high aspect ratio and high depth capability has been specially developed. Long range scanning mechanism with tilt-adjustment stage is adopted for the purpose of adjusting the probe-sample relative angle to compensate the non-parallel effects. A periodical trench microstructure with a pitch of 10 μm has been successfully imaged with a long scanning range up to 2.0 mm. More innovatively, a deep trench with depth and step height of 23.0 μm has also been successfully measured, and slope angle of the sidewall can approximately achieve 67°. The probe can continuously climb the high step and exploring the trench bottom without tip crashing. The new STM could perform long range measurement for the deep trench and high step surfaces without image distortion. It enables accurate measurement and quality control of periodical trench microstructures.

  16. Tasting soil fungal diversity with earth tongues: phylogenetic test of SATe alignments for environmental ITS data.

    Directory of Open Access Journals (Sweden)

    Zheng Wang

    Full Text Available An abundance of novel fungal lineages have been indicated by DNA sequencing of the nuclear ribosomal ITS region from environmental samples such as soil and wood. Although phylogenetic analysis of these novel lineages is a key component of unveiling the structure and diversity of complex communities, such analyses are rare for environmental ITS data due to the difficulties of aligning this locus across significantly divergent taxa. One potential approach to this issue is simultaneous alignment and tree estimation. We targeted divergent ITS sequences of the earth tongue fungi (Geoglossomycetes, a basal class in the Ascomycota, to assess the performance of SATé, recent software that combines progressive alignment and tree building. We found that SATé performed well in generating high-quality alignments and in accurately estimating the phylogeny of earth tongue fungi. Drawing from a data set of 300 sequences of earth tongues and progressively more distant fungal lineages, 30 insufficiently identified ITS sequences from the public sequence databases were assigned to the Geoglossomycetes. The association between earth tongues and plants has been hypothesized for a long time, but hard evidence is yet to be collected. The ITS phylogeny showed that four ectomycorrhizal isolates shared a clade with Geoglossum but not with Trichoglossum earth tongues, pointing to the significant potential inherent to ecological data mining of environmental samples. Environmental sampling holds the key to many focal questions in mycology, and simultaneous alignment and tree estimation, as performed by SATé, can be a highly efficient companion in that pursuit.

  17. Beam alignment based on two-dimensional power spectral density of a near-field image.

    Science.gov (United States)

    Wang, Shenzhen; Yuan, Qiang; Zeng, Fa; Zhang, Xin; Zhao, Junpu; Li, Kehong; Zhang, Xiaolu; Xue, Qiao; Yang, Ying; Dai, Wanjun; Zhou, Wei; Wang, Yuanchen; Zheng, Kuixing; Su, Jingqin; Hu, Dongxia; Zhu, Qihua

    2017-10-30

    Beam alignment is crucial to high-power laser facilities and is used to adjust the laser beams quickly and accurately to meet stringent requirements of pointing and centering. In this paper, a novel alignment method is presented, which employs data processing of the two-dimensional power spectral density (2D-PSD) for a near-field image and resolves the beam pointing error relative to the spatial filter pinhole directly. Combining this with a near-field fiducial mark, the operation of beam alignment is achieved. It is experimentally demonstrated that this scheme realizes a far-field alignment precision of approximately 3% of the pinhole size. This scheme adopts only one near-field camera to construct the alignment system, which provides a simple, efficient, and low-cost way to align lasers.

  18. Open Reading Frame Phylogenetic Analysis on the Cloud

    Directory of Open Access Journals (Sweden)

    Che-Lun Hung

    2013-01-01

    Full Text Available Phylogenetic analysis has become essential in researching the evolutionary relationships between viruses. These relationships are depicted on phylogenetic trees, in which viruses are grouped based on sequence similarity. Viral evolutionary relationships are identified from open reading frames rather than from complete sequences. Recently, cloud computing has become popular for developing internet-based bioinformatics tools. Biocloud is an efficient, scalable, and robust bioinformatics computing service. In this paper, we propose a cloud-based open reading frame phylogenetic analysis service. The proposed service integrates the Hadoop framework, virtualization technology, and phylogenetic analysis methods to provide a high-availability, large-scale bioservice. In a case study, we analyze the phylogenetic relationships among Norovirus. Evolutionary relationships are elucidated by aligning different open reading frame sequences. The proposed platform correctly identifies the evolutionary relationships between members of Norovirus.

  19. The Role of Consulting a Dictionary in Reading and Vocabulary Learning

    Directory of Open Access Journals (Sweden)

    Carol A. Fraser

    1999-12-01

    Full Text Available Abstract This article reviews recent research on consulting a dictionary in L2 reading and vocabulary learning. From the perspective of cognitive learning theory, the author re-evaluates the limited role that has often been accorded to dictionary consulting. It is noted that, among the three available lexical processing strategies (inferencing, consulting and ignoring, learners tend to use consulting infrequently and selectively and also to differ among each other in their strategy use. Consulting in combination with inferencing is shown to have the greatest positive effect on performance in L2 reading and vocabulary learning, although consulting is found to slow down task completion. Excerpts from think-aloud protocols illustrate the potential contribution of strategic dictionary use to the cognitive processes required for vocabulary acquisition: attention to form-meaning connections, rehearsal of words for storage in long-term memory and elaboration of associations with other knowledge. Among the pedagogical implications of these findings is the need for training in lexical processing strategies in order to help learners use the dictionary effectively and accurately in L2 reading comprehension and vocabulary learning.

  20. Planar self-aligned imprint lithography for coplanar plasmonic nanostructures fabrication

    KAUST Repository

    Wan, Weiwei

    2014-03-01

    Nanoimprint lithography (NIL) is a cost-efficient nanopatterning technology because of its promising advantages of high throughput and high resolution. However, accurate multilevel overlay capability of NIL required for integrated circuit manufacturing remains a challenge due to the high cost of achieving mechanical alignment precision. Although self-aligned imprint lithography was developed to avoid the need of alignment for the vertical layered structures, it has limited usage in the manufacture of the coplanar structures, such as integrated plasmonic devices. In this paper, we develop a new process of planar self-alignment imprint lithography (P-SAIL) to fabricate the metallic and dielectric structures on the same plane. P-SAIL transfers the multilevel imprint processes to a single-imprint process which offers higher efficiency and less cost than existing manufacturing methods. Such concept is demonstrated in an example of fabricating planar plasmonic structures consisting of different materials. © 2014 Springer-Verlag Berlin Heidelberg.

  1. Using quality scores and longer reads improves accuracy of Solexa read mapping

    Directory of Open Access Journals (Sweden)

    Xuan Zhenyu

    2008-02-01

    Full Text Available Abstract Background Second-generation sequencing has the potential to revolutionize genomics and impact all areas of biomedical science. New technologies will make re-sequencing widely available for such applications as identifying genome variations or interrogating the oligonucleotide content of a large sample (e.g. ChIP-sequencing. The increase in speed, sensitivity and availability of sequencing technology brings demand for advances in computational technology to perform associated analysis tasks. The Solexa/Illumina 1G sequencer can produce tens of millions of reads, ranging in length from ~25–50 nt, in a single experiment. Accurately mapping the reads back to a reference genome is a critical task in almost all applications. Two sources of information that are often ignored when mapping reads from the Solexa technology are the 3' ends of longer reads, which contain a much higher frequency of sequencing errors, and the base-call quality scores. Results To investigate whether these sources of information can be used to improve accuracy when mapping reads, we developed the RMAP tool, which can map reads having a wide range of lengths and allows base-call quality scores to determine which positions in each read are more important when mapping. We applied RMAP to analyze data re-sequenced from two human BAC regions for varying read lengths, and varying criteria for use of quality scores. RMAP is freely available for downloading at http://rulai.cshl.edu/rmap/. Conclusion Our results indicate that significant gains in Solexa read mapping performance can be achieved by considering the information in 3' ends of longer reads, and appropriately using the base-call quality scores. The RMAP tool we have developed will enable researchers to effectively exploit this information in targeted re-sequencing projects.

  2. 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...

  3. 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).

  4. Wire alignment system for ATF LINAC

    International Nuclear Information System (INIS)

    Hayano, H.; Takeda, S.; Matsumoto, H.; Matsui, T.

    1994-01-01

    A wire based alignment system is adopted to make less than 40μm precision alignment for injector linac of Accelerator Test Facility (ATF). The system consists of two stretched SUS wires, pickup coils and active mover stages. The position of pickup coils in a mount which will be installed into LINAC stages is set to the calculated wire position prior to installation. All of LINAC stages are then moved to keep the calculated position by the active mover. The test results of wire position detection in a long term are described. (author)

  5. Reading Sacred Texts in the Classroom: The Alignment between Students and Their Teacher's Interpretive Stances When Reading the Hebrew Bible

    Science.gov (United States)

    Hassenfeld, Ziva R.

    2016-01-01

    This study investigated the voices of students interpreting Hebrew Bible texts in one fourth-grade classroom. Through think-alouds on the Biblical text with each student, exit interviews, teacher interviews, and classroom observations, this study found that those students whose interpretive stances were more aligned with the teacher's were given…

  6. Quasiparticle Level Alignment for Photocatalytic Interfaces.

    Science.gov (United States)

    Migani, Annapaoala; Mowbray, Duncan J; Zhao, Jin; Petek, Hrvoje; Rubio, Angel

    2014-05-13

    Electronic level alignment at the interface between an adsorbed molecular layer and a semiconducting substrate determines the activity and efficiency of many photocatalytic materials. Standard density functional theory (DFT)-based methods have proven unable to provide a quantitative description of this level alignment. This requires a proper treatment of the anisotropic screening, necessitating the use of quasiparticle (QP) techniques. However, the computational complexity of QP algorithms has meant a quantitative description of interfacial levels has remained elusive. We provide a systematic study of a prototypical interface, bare and methanol-covered rutile TiO2(110) surfaces, to determine the type of many-body theory required to obtain an accurate description of the level alignment. This is accomplished via a direct comparison with metastable impact electron spectroscopy (MIES), ultraviolet photoelectron spectroscopy (UPS), and two-photon photoemission (2PP) spectroscopy. We consider GGA DFT, hybrid DFT, and G0W0, scQPGW1, scQPGW0, and scQPGW QP calculations. Our results demonstrate that G0W0, or our recently introduced scQPGW1 approach, are required to obtain the correct alignment of both the highest occupied and lowest unoccupied interfacial molecular levels (HOMO/LUMO). These calculations set a new standard in the interpretation of electronic structure probe experiments of complex organic molecule/semiconductor interfaces.

  7. Measurements of magnetic field alignment

    International Nuclear Information System (INIS)

    Kuchnir, M.; Schmidt, E.E.

    1987-01-01

    The procedure for installing Superconducting Super Collider (SSC) dipoles in their respective cryostats involves aligning the average direction of their field with the vertical to an accuracy of 0.5 mrad. The equipment developed for carrying on these measurements is described and the measurements performed on the first few prototypes SSC magnets are presented. The field angle as a function of position in these 16.6 m long magnets is a characteristic of the individual magnet with possible feedback information to its manufacturing procedure. A comparison of this vertical alignment characteristic with a magnetic field intensity (by NMR) characteristic for one of the prototypes is also presented. 5 refs., 7 figs

  8. The Effect of Key on Vocal Sight-Reading Achievement

    Science.gov (United States)

    Henry, Michele L.

    2013-01-01

    At its most basic level, sight-reading can be defined as the production of accurate pitch and rhythm from a previously unseen musical score. For vocalists, sight-reading principally involves the production of pitches by determining their relationship within a tonal framework. The ability to mentally conceive tonal function and convert it into…

  9. L-GRAAL: Lagrangian graphlet-based network aligner.

    Science.gov (United States)

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

    2015-07-01

    Discovering and understanding patterns in networks of protein-protein interactions (PPIs) is a central problem in systems biology. Alignments between these networks aid functional understanding as they uncover important information, such as evolutionary conserved pathways, protein complexes and functional orthologs. A few methods have been proposed for global PPI network alignments, but because of NP-completeness of underlying sub-graph isomorphism problem, producing topologically and biologically accurate alignments remains a challenge. We introduce a novel global network alignment tool, Lagrangian GRAphlet-based ALigner (L-GRAAL), which directly optimizes both the protein and the interaction functional conservations, using a novel alignment search heuristic based on integer programming and Lagrangian relaxation. We compare L-GRAAL with the state-of-the-art network aligners on the largest available PPI networks from BioGRID and observe that L-GRAAL uncovers the largest common sub-graphs between the networks, as measured by edge-correctness and symmetric sub-structures scores, which allow transferring more functional information across networks. We assess the biological quality of the protein mappings using the semantic similarity of their Gene Ontology annotations and observe that L-GRAAL best uncovers functionally conserved proteins. Furthermore, we introduce for the first time a measure of the semantic similarity of the mapped interactions and show that L-GRAAL also uncovers best functionally conserved interactions. In addition, we illustrate on the PPI networks of baker's yeast and human the ability of L-GRAAL to predict new PPIs. Finally, L-GRAAL's results are the first to show that topological information is more important than sequence information for uncovering functionally conserved interactions. L-GRAAL is coded in C++. Software is available at: http://bio-nets.doc.ic.ac.uk/L-GRAAL/. n.malod-dognin@imperial.ac.uk Supplementary data are available at

  10. Bridging Theory and Practice: Developing Lower-Level Skills in L2 Reading

    Science.gov (United States)

    Kato, Shigeo

    2012-01-01

    Studies on L2 reading have provided extensive evidence for the significant contribution of lower-level processing skills in learning to read and the critical impact on the overall development of L2 reading of more accurate and fluent connections between three sub-lexical components: phonology, orthography and semantics. The broad consensus among…

  11. Discovering transcription factor binding sites in highly repetitive regions of genomes with multi-read analysis of ChIP-Seq data.

    Science.gov (United States)

    Chung, Dongjun; Kuan, Pei Fen; Li, Bo; Sanalkumar, Rajendran; Liang, Kun; Bresnick, Emery H; Dewey, Colin; Keleş, Sündüz

    2011-07-01

    Chromatin immunoprecipitation followed by high-throughput sequencing (ChIP-seq) is rapidly replacing chromatin immunoprecipitation combined with genome-wide tiling array analysis (ChIP-chip) as the preferred approach for mapping transcription-factor binding sites and chromatin modifications. The state of the art for analyzing ChIP-seq data relies on using only reads that map uniquely to a relevant reference genome (uni-reads). This can lead to the omission of up to 30% of alignable reads. We describe a general approach for utilizing reads that map to multiple locations on the reference genome (multi-reads). Our approach is based on allocating multi-reads as fractional counts using a weighted alignment scheme. Using human STAT1 and mouse GATA1 ChIP-seq datasets, we illustrate that incorporation of multi-reads significantly increases sequencing depths, leads to detection of novel peaks that are not otherwise identifiable with uni-reads, and improves detection of peaks in mappable regions. We investigate various genome-wide characteristics of peaks detected only by utilization of multi-reads via computational experiments. Overall, peaks from multi-read analysis have similar characteristics to peaks that are identified by uni-reads except that the majority of them reside in segmental duplications. We further validate a number of GATA1 multi-read only peaks by independent quantitative real-time ChIP analysis and identify novel target genes of GATA1. These computational and experimental results establish that multi-reads can be of critical importance for studying transcription factor binding in highly repetitive regions of genomes with ChIP-seq experiments.

  12. Discovering transcription factor binding sites in highly repetitive regions of genomes with multi-read analysis of ChIP-Seq data.

    Directory of Open Access Journals (Sweden)

    Dongjun Chung

    2011-07-01

    Full Text Available Chromatin immunoprecipitation followed by high-throughput sequencing (ChIP-seq is rapidly replacing chromatin immunoprecipitation combined with genome-wide tiling array analysis (ChIP-chip as the preferred approach for mapping transcription-factor binding sites and chromatin modifications. The state of the art for analyzing ChIP-seq data relies on using only reads that map uniquely to a relevant reference genome (uni-reads. This can lead to the omission of up to 30% of alignable reads. We describe a general approach for utilizing reads that map to multiple locations on the reference genome (multi-reads. Our approach is based on allocating multi-reads as fractional counts using a weighted alignment scheme. Using human STAT1 and mouse GATA1 ChIP-seq datasets, we illustrate that incorporation of multi-reads significantly increases sequencing depths, leads to detection of novel peaks that are not otherwise identifiable with uni-reads, and improves detection of peaks in mappable regions. We investigate various genome-wide characteristics of peaks detected only by utilization of multi-reads via computational experiments. Overall, peaks from multi-read analysis have similar characteristics to peaks that are identified by uni-reads except that the majority of them reside in segmental duplications. We further validate a number of GATA1 multi-read only peaks by independent quantitative real-time ChIP analysis and identify novel target genes of GATA1. These computational and experimental results establish that multi-reads can be of critical importance for studying transcription factor binding in highly repetitive regions of genomes with ChIP-seq experiments.

  13. [Developmental changes in reading ability of Japanese elementary school children--analysis of 4 kana reading tasks].

    Science.gov (United States)

    Kobayashi, Tomoka; Inagaki, Masumi; Gunji, Atsuko; Yatabe, Kiyomi; Kaga, Makiko; Goto, Takaaki; Koike, Toshihide; Wakamiya, Eiji; Koeda, Tatsuya

    2010-01-01

    Five hundred and twenty-eight Japanese elementary school children aged from 6 (Grade 1) to 12 (Grade 6) were tested for their abilities to read Hiragana characters, words, and short sentences. They were typically developing children whom the classroom teachers judged to have no problems with reading and writing in Japanese. Each child was asked to read four tasks which were written in Hiragana script: single mora reading task, four syllable non-word reading task, four syllable word reading task, and short sentence reading task. The total articulation time for reading and performance in terms of accuracy were measured for each task. Developmental changes in these variables were evaluated. The articulation time was significantly longer for the first graders, and it gradually shortened as they moved through to the upper grades in all tasks. The articulation time reached a plateau in the 4th grade for the four syllable word and short sentence reading tasks, while it did so for the single mora and four syllable non-word reading tasks in the 5th grade. The articulation times for the four syllable word and short sentence reading tasks correlated strongly. There were very few clear errors for all tasks, and the number of such errors significantly changed between the school grades only for the single mora and four syllable word reading tasks. It was noted that more than half of the children read the beginning portion of the word or phrase twice or more, in order to read it accurately, and developmental changes were also seen in this pattern of reading. This study revealed that the combination of these reading tasks may function as a screening test for reading disorders such as developmental dyslexia in children below the age of ten or eleven years old.

  14. Alignment of in-vessel components by metrology defined adaptive machining

    International Nuclear Information System (INIS)

    Wilson, David; Bernard, Nathanaël; Mariani, Antony

    2015-01-01

    Highlights: • Advanced metrology techniques developed for large volume high density in-vessel surveys. • Virtual alignment process employed to optimize the alignment of 440 blanket modules. • Auto-geometry construct, from survey data, using CAD proximity detection and orientation logic. • HMI developed to relocate blanket modules if customization limits on interfaces are exceeded. • Data export format derived for Catia parametric models, defining customization requirements. - Abstract: The assembly of ITER will involve the precise and accurate alignment of a large number of components and assemblies in areas where access will often be severely constrained and where process efficiency will be critical. One such area is the inside of the vacuum vessel where several thousand components shall be custom machined to provide the alignment references for in-vessel systems. The paper gives an overview of the process that will be employed; to survey the interfaces for approximately 3500 components then define and execute the customization process.

  15. Alignment of in-vessel components by metrology defined adaptive machining

    Energy Technology Data Exchange (ETDEWEB)

    Wilson, David [ITER Organization, Route de Vinon sur Verdon, CS90 046, St Paul-lez-Durance (France); Bernard, Nathanaël [G2Métric, Launaguet 31140 (France); Mariani, Antony [Spatial Alignment Ltd., Witney (United Kingdom)

    2015-10-15

    Highlights: • Advanced metrology techniques developed for large volume high density in-vessel surveys. • Virtual alignment process employed to optimize the alignment of 440 blanket modules. • Auto-geometry construct, from survey data, using CAD proximity detection and orientation logic. • HMI developed to relocate blanket modules if customization limits on interfaces are exceeded. • Data export format derived for Catia parametric models, defining customization requirements. - Abstract: The assembly of ITER will involve the precise and accurate alignment of a large number of components and assemblies in areas where access will often be severely constrained and where process efficiency will be critical. One such area is the inside of the vacuum vessel where several thousand components shall be custom machined to provide the alignment references for in-vessel systems. The paper gives an overview of the process that will be employed; to survey the interfaces for approximately 3500 components then define and execute the customization process.

  16. Best Practices for Achieving High, Rapid Reading Gains

    Science.gov (United States)

    Carbo, Marie

    2008-01-01

    The percentage of students who read at the proficient level on the National Assessment of Educational Progress (NAEP) has not improved, and is appallingly low. In order for students to achieve high reading gains and become life-long readers, reading comprehension and reading enjoyment must be the top two goals. This article presents several…

  17. Alignment of the Thomson scattering diagnostic on NSTX

    International Nuclear Information System (INIS)

    LeBlanc, B P; Diallo, A

    2013-01-01

    The Thomson scattering diagnostic can provide profile measurement of the electron temperature, T e , and density, n e , in plasmas. Proper laser beam path and optics arrangement permits profiles T e (R) and n e (R) measurement along the major radius R. Keeping proper alignment between the laser beam path and the collection optics is necessary for an accurate determination of the electron density. As time progresses the relative position of the collection optics field of view with respect to the laser beam path will invariably shift. This can be kept to a minimum by proper attention to the physical arrangement of the collection and laser-beam delivery optics. A system has been in place to monitor the relative position between laser beam and collection optics. Variation of the alignment can be detected before it begins to affect the quality of the profile data. This paper discusses details of the instrumentation and techniques used to maintain alignment during NSTX multi-month experimental campaigns

  18. Fine-tuning structural RNA alignments in the twilight zone

    Directory of Open Access Journals (Sweden)

    Schirmer Stefanie

    2010-04-01

    Full Text Available Abstract Background A widely used method to find conserved secondary structure in RNA is to first construct a multiple sequence alignment, and then fold the alignment, optimizing a score based on thermodynamics and covariance. This method works best around 75% sequence similarity. However, in a "twilight zone" below 55% similarity, the sequence alignment tends to obscure the covariance signal used in the second phase. Therefore, while the overall shape of the consensus structure may still be found, the degree of conservation cannot be estimated reliably. Results Based on a combination of available methods, we present a method named planACstar for improving structure conservation in structural alignments in the twilight zone. After constructing a consensus structure by alignment folding, planACstar abandons the original sequence alignment, refolds the sequences individually, but consistent with the consensus, aligns the structures, irrespective of sequence, by a pure structure alignment method, and derives an improved sequence alignment from the alignment of structures, to be re-submitted to alignment folding, etc.. This circle may be iterated as long as structural conservation improves, but normally, one step suffices. Conclusions Employing the tools ClustalW, RNAalifold, and RNAforester, we find that for sequences with 30-55% sequence identity, structural conservation can be improved by 10% on average, with a large variation, measured in terms of RNAalifold's own criterion, the structure conservation index.

  19. Evaluating a Brief Measure of Reading Comprehension for Narrative and Expository Text: The Convergent and Predictive Validity of the Reading Retell Rubric

    Science.gov (United States)

    Thomas, Lisa B.

    2012-01-01

    Reading comprehension is a critical aspect of the reading process. Children who experience significant problems in reading comprehension are at risk for long-term academic and social problems. High-quality measures are needed for early, efficient, and effective identification of children in need of remediation in reading comprehension. Substantial…

  20. RSEM: accurate transcript quantification from RNA-Seq data with or without a reference genome

    Directory of Open Access Journals (Sweden)

    Dewey Colin N

    2011-08-01

    Full Text Available Abstract Background RNA-Seq is revolutionizing the way transcript abundances are measured. A key challenge in transcript quantification from RNA-Seq data is the handling of reads that map to multiple genes or isoforms. This issue is particularly important for quantification with de novo transcriptome assemblies in the absence of sequenced genomes, as it is difficult to determine which transcripts are isoforms of the same gene. A second significant issue is the design of RNA-Seq experiments, in terms of the number of reads, read length, and whether reads come from one or both ends of cDNA fragments. Results We present RSEM, an user-friendly software package for quantifying gene and isoform abundances from single-end or paired-end RNA-Seq data. RSEM outputs abundance estimates, 95% credibility intervals, and visualization files and can also simulate RNA-Seq data. In contrast to other existing tools, the software does not require a reference genome. Thus, in combination with a de novo transcriptome assembler, RSEM enables accurate transcript quantification for species without sequenced genomes. On simulated and real data sets, RSEM has superior or comparable performance to quantification methods that rely on a reference genome. Taking advantage of RSEM's ability to effectively use ambiguously-mapping reads, we show that accurate gene-level abundance estimates are best obtained with large numbers of short single-end reads. On the other hand, estimates of the relative frequencies of isoforms within single genes may be improved through the use of paired-end reads, depending on the number of possible splice forms for each gene. Conclusions RSEM is an accurate and user-friendly software tool for quantifying transcript abundances from RNA-Seq data. As it does not rely on the existence of a reference genome, it is particularly useful for quantification with de novo transcriptome assemblies. In addition, RSEM has enabled valuable guidance for cost

  1. HapCol : Accurate and memory-efficient haplotype assembly from long reads

    NARCIS (Netherlands)

    Pirola, Yuri; Zaccaria, Simone; Dondi, Riccardo; Klau, Gunnar W.; Pisanti, Nadia; Bonizzoni, Paola

    2016-01-01

    Motivation: Haplotype assembly is the computational problem of reconstructing haplotypes in diploid organisms and is of fundamental importance for characterizing the effects of single-nucleotide polymorphisms on the expression of phenotypic traits. Haplotype assembly highly benefits from the advent

  2. HapCol: Accurate and Memory-efficient Haplotype Assembly from Long Reads

    NARCIS (Netherlands)

    Y. Pirola (Yuri); S. Zaccaria (Simone); R. Dondi (Riccardo); G.W. Klau (Gunnar); N. Pisanti (Nadia); P. Bonizzoni (Paola)

    2015-01-01

    htmlabstractMotivation: Haplotype assembly is the computational problem of reconstructing haplotypes in diploid organisms and is of fundamental importance for characterizing the effects of single-nucleotide polymorphisms on the expression of phenotypic traits. Haplotype assembly highly benefits from

  3. A Python Script for Aligning the STIS Echelle Blaze Function

    Science.gov (United States)

    Baer, Malinda; Proffitt, Charles R.; Lockwood, Sean A.

    2018-01-01

    Accurate flux calibration for the STIS echelle modes is heavily dependent on the proper alignment of the blaze function for each spectral order. However, due to changes in the instrument alignment over time and between exposures, the blaze function can shift in wavelength. This may result in flux calibration inconsistencies of up to 10%. We present the stisblazefix Python module as a tool for STIS users to correct their echelle spectra. The stisblazefix module assumes that the error in the blaze alignment is a linear function of spectral order, and finds the set of shifts that minimizes the flux inconsistencies in the overlap between spectral orders. We discuss the uses and limitations of this tool, and show that its use can provide significant improvements to the default pipeline flux calibration for many observations.

  4. Cryo-EM image alignment based on nonuniform fast Fourier transform

    International Nuclear Information System (INIS)

    Yang Zhengfan; Penczek, Pawel A.

    2008-01-01

    In single particle analysis, two-dimensional (2-D) alignment is a fundamental step intended to put into register various particle projections of biological macromolecules collected at the electron microscope. The efficiency and quality of three-dimensional (3-D) structure reconstruction largely depends on the computational speed and alignment accuracy of this crucial step. In order to improve the performance of alignment, we introduce a new method that takes advantage of the highly accurate interpolation scheme based on the gridding method, a version of the nonuniform fast Fourier transform, and utilizes a multi-dimensional optimization algorithm for the refinement of the orientation parameters. Using simulated data, we demonstrate that by using less than half of the sample points and taking twice the runtime, our new 2-D alignment method achieves dramatically better alignment accuracy than that based on quadratic interpolation. We also apply our method to image to volume registration, the key step in the single particle EM structure refinement protocol. We find that in this case the accuracy of the method not only surpasses the accuracy of the commonly used real-space implementation, but results are achieved in much shorter time, making gridding-based alignment a perfect candidate for efficient structure determination in single particle analysis

  5. Cryo-EM image alignment based on nonuniform fast Fourier transform.

    Science.gov (United States)

    Yang, Zhengfan; Penczek, Pawel A

    2008-08-01

    In single particle analysis, two-dimensional (2-D) alignment is a fundamental step intended to put into register various particle projections of biological macromolecules collected at the electron microscope. The efficiency and quality of three-dimensional (3-D) structure reconstruction largely depends on the computational speed and alignment accuracy of this crucial step. In order to improve the performance of alignment, we introduce a new method that takes advantage of the highly accurate interpolation scheme based on the gridding method, a version of the nonuniform fast Fourier transform, and utilizes a multi-dimensional optimization algorithm for the refinement of the orientation parameters. Using simulated data, we demonstrate that by using less than half of the sample points and taking twice the runtime, our new 2-D alignment method achieves dramatically better alignment accuracy than that based on quadratic interpolation. We also apply our method to image to volume registration, the key step in the single particle EM structure refinement protocol. We find that in this case the accuracy of the method not only surpasses the accuracy of the commonly used real-space implementation, but results are achieved in much shorter time, making gridding-based alignment a perfect candidate for efficient structure determination in single particle analysis.

  6. RNA structure alignment by a unit-vector approach.

    Science.gov (United States)

    Capriotti, Emidio; Marti-Renom, Marc A

    2008-08-15

    The recent discovery of tiny RNA molecules such as microRNAs and small interfering RNA are transforming the view of RNA as a simple information transfer molecule. Similar to proteins, the native three-dimensional structure of RNA determines its biological activity. Therefore, classifying the current structural space is paramount for functionally annotating RNA molecules. The increasing numbers of RNA structures deposited in the PDB requires more accurate, automatic and benchmarked methods for RNA structure comparison. In this article, we introduce a new algorithm for RNA structure alignment based on a unit-vector approach. The algorithm has been implemented in the SARA program, which results in RNA structure pairwise alignments and their statistical significance. The SARA program has been implemented to be of general applicability even when no secondary structure can be calculated from the RNA structures. A benchmark against the ARTS program using a set of 1275 non-redundant pairwise structure alignments results in inverted approximately 6% extra alignments with at least 50% structurally superposed nucleotides and base pairs. A first attempt to perform RNA automatic functional annotation based on structure alignments indicates that SARA can correctly assign the deepest SCOR classification to >60% of the query structures. The SARA program is freely available through a World Wide Web server http://sgu.bioinfo.cipf.es/services/SARA/. Supplementary data are available at Bioinformatics online.

  7. Accurately bearing measurement in non-cooperative passive location system

    International Nuclear Information System (INIS)

    Liu Zhiqiang; Ma Hongguang; Yang Lifeng

    2007-01-01

    The system of non-cooperative passive location based on array is proposed. In the system, target is detected by beamforming and Doppler matched filtering; and bearing is measured by a long-base-ling interferometer which is composed of long distance sub-arrays. For the interferometer with long-base-line, the bearing is measured accurately but ambiguously. To realize unambiguous accurately bearing measurement, beam width and multiple constraint adoptive beamforming technique is used to resolve azimuth ambiguous. Theory and simulation result shows this method is effective to realize accurately bearing measurement in no-cooperate passive location system. (authors)

  8. Foreign language reading and spelling in gifted students with dyslexia in secondary education

    NARCIS (Netherlands)

    Van Viersen, Sietske; De Bree, Elise H.; Kalee, Lilian; Kroesbergen, Evelyn H.; De Jong, Peter F.

    2017-01-01

    A few studies suggest that gifted children with dyslexia have better literacy skills than averagely intelligent children with dyslexia. This finding aligns with the hypothesis that giftedness-related factors provide compensation for poor reading. The present study investigated whether, as in the

  9. Foreign language reading and spelling in gifted students with dyslexia in secondary education

    NARCIS (Netherlands)

    van Viersen, S.; de Bree, E.H.; Kalee, L.; Kroesbergen, E.H.; de Jong, P.F.

    A few studies suggest that gifted children with dyslexia have better literacy skills than averagely intelligent children with dyslexia. This finding aligns with the hypothesis that giftedness-related factors provide compensation for poor reading. The present study investigated whether, as in the

  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. Effect of Long Term Oral Warfarin Sodium Treatment on Bone Mineral Density Scores and Spinal Sagittal Alignment

    Directory of Open Access Journals (Sweden)

    Kamil Eyvazov

    2016-04-01

    Full Text Available Objective: The aim of this study was to investigate the effect of long term oral warfarin sodium treatment on bone mineral density (BMD and spinal sagittal alignment. Materials and Methods: Sixty four participants were enrolled for this retrospective study. Participants were divided into two groups-participants who had taken warfarin sodium for at least two years (n=33 and participants who had never taken warfarin sodium (n=31. All of the individuals were evaluated at the same center. Dual X-ray absorptiometry (DXA was used for measuring BMD. Whole spine x-rays were obtained for sagittal assessment and the following parameters were measured: Cervical lordosis, thoracic kyphosis, lumbar lordosis, pelvic incidence, pelvic tilt, sacral slope and sagittal vertical axis (SVA. Results: The mean BMD value was significantly higher in participants who had not taken warfarin sodium compared to participants who had taken warfarin sodium. The differences between the average values were 0.1552 g/cm2 in BMD; 2.1 in T scores; 1.4 in Z scores. On the radiological evaluation of the spine, cervical lordosis was 7.1 degrees lower, lumbar lordosis was 4.7 degrees lower and thoracic kyphosis was 5.3 degrees higher in the patients using drug. C7 plumb line was interchanged forward in the patients using drug. Conclusions: This study shows that warfarin sodium use worsens bone quality in the lumbar region and does not affect bone quality in the femoral region. Furthermore, warfarin sodium use also reduces physiological lordosis and enhances thoracic kyphosis. Consequences of these changes are the likely cause of sagittal spinal anterior imbalance. Long-term oral warfarin sodium use affect bone mineral density and spinal alignment. Our conclusion about giving clear message and show exactly mechanism we need prospective randomized multicentre studies in future. We strongly believe this study will be pioneer for future researches.

  12. Lessons learnt: Observation of Grade 4 reading comprehension teaching in South African schools across the Progress in International Reading Literacy Study (PIRLS 2006 achievement spectrum

    Directory of Open Access Journals (Sweden)

    Lisa Zimmerman

    2014-12-01

    Full Text Available The evidence of the huge challenges of literacy development faced by South African learners is primarily gleaned from the results of learners’ external assessments. There is little research which explores, in-depth, the strategies used by teachers to teach reading literacy and reading comprehension specifically. Questions remain about what is going wrong and, most importantly,what can be changed to rectify the poor outcomes of learners. To gain insight into the poor achievement of Grade 4 learners, in South Africa in the Progress in International Reading Literacy Study (PIRLS 2006, six case studies were undertaken. Each school case had a different class average achievement profile ranging from low to high on the PIRLS achievement scale.This article presents findings from the observation of Grade 4 reading comprehension lessons in six schools. The comparison of observations of teaching practices aligned to higher achieving schools, against those of lower performing schools, indicates the discrepancies in the quality of teaching reading comprehension across the schools, and reveals potential foci for teacher development. The value of comparative lesson observation for these purposes is highlighted.

  13. Development of the laser alignment system with PSD used for shaft calibration

    Science.gov (United States)

    Jiao, Guohua; Li, Yulin; Hu, Baowen

    2006-02-01

    Shaft calibration is an important technique during installation and maintenance of a rotating machine. It requires unique and high-precision measurement instruments with calculation capability, and relies on experience on heavy, high-speed, or high-temperature machines. A high-precision laser alignment system has been designed using PSD (Position Sensing Detector) to change traditional manual way of shaft calibration and to make the measurement easier and more accurate. The system is comprised of two small measuring units (Laser transmitter and detector) and a hand operated control unit or a PC. Such a laser alignment system has been used in some actual shaft alignment with offset resolution 1.5μm and angular resolution 0.1°.

  14. Aligning ERP and Business Strategy after going live

    DEFF Research Database (Denmark)

    Koch, Christian

    2004-01-01

    Steering enterprises with Enterprise Resource Planning systems (ERP) is not only an issue of implementation and of “once and for all” aligning the ERP system with the strategy of the company, it is a long term exercise. This paper is about managing ERP systems after going live. It is argued...... that companies has to align the ERP systems with the strategy of the company and guidelines as to how this can be achieved is given....

  15. In-Flight Self-Alignment Method Aided by Geomagnetism for Moving Basement of Guided Munitions

    Directory of Open Access Journals (Sweden)

    Shuang-biao Zhang

    2015-01-01

    Full Text Available Due to power-after-launch mode of guided munitions of high rolling speed, initial attitude of munitions cannot be determined accurately, and this makes it difficult for navigation and control system to work effectively and validly. An in-flight self-alignment method aided by geomagnetism that includes a fast in-flight coarse alignment method and an in-flight alignment model based on Kalman theory is proposed in this paper. Firstly a fast in-flight coarse alignment method is developed by using gyros, magnetic sensors, and trajectory angles. Then, an in-flight alignment model is derived by investigation of the measurement errors and attitude errors, which regards attitude errors as state variables and geomagnetic components in navigation frame as observed variables. Finally, fight data of a spinning projectile is used to verify the performance of the in-flight self-alignment method. The satisfying results show that (1 the precision of coarse alignment can attain below 5°; (2 the attitude errors by in-flight alignment model converge to 24′ at early of the latter half of the flight; (3 the in-flight alignment model based on Kalman theory has better adaptability, and show satisfying performance.

  16. 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.

  17. Brain bases of reading fluency in typical reading and impaired fluency in dyslexia.

    Directory of Open Access Journals (Sweden)

    Joanna A Christodoulou

    Full Text Available Although the neural systems supporting single word reading are well studied, there are limited direct comparisons between typical and dyslexic readers of the neural correlates of reading fluency. Reading fluency deficits are a persistent behavioral marker of dyslexia into adulthood. The current study identified the neural correlates of fluent reading in typical and dyslexic adult readers, using sentences presented in a word-by-word format in which single words were presented sequentially at fixed rates. Sentences were presented at slow, medium, and fast rates, and participants were asked to decide whether each sentence did or did not make sense semantically. As presentation rates increased, participants became less accurate and slower at making judgments, with comprehension accuracy decreasing disproportionately for dyslexic readers. In-scanner performance on the sentence task correlated significantly with standardized clinical measures of both reading fluency and phonological awareness. Both typical readers and readers with dyslexia exhibited widespread, bilateral increases in activation that corresponded to increases in presentation rate. Typical readers exhibited significantly larger gains in activation as a function of faster presentation rates than readers with dyslexia in several areas, including left prefrontal and left superior temporal regions associated with semantic retrieval and semantic and phonological representations. Group differences were more extensive when behavioral differences between conditions were equated across groups. These findings suggest a brain basis for impaired reading fluency in dyslexia, specifically a failure of brain regions involved in semantic retrieval and semantic and phonological representations to become fully engaged for comprehension at rapid reading rates.

  18. Prediction of MHC class II binding affinity using SMM-align, a novel stabilization matrix alignment method.

    Science.gov (United States)

    Nielsen, Morten; Lundegaard, Claus; Lund, Ole

    2007-07-04

    Antigen presenting cells (APCs) sample the extra cellular space and present peptides from here to T helper cells, which can be activated if the peptides are of foreign origin. The peptides are presented on the surface of the cells in complex with major histocompatibility class II (MHC II) molecules. Identification of peptides that bind MHC II molecules is thus a key step in rational vaccine design and developing methods for accurate prediction of the peptide:MHC interactions play a central role in epitope discovery. The MHC class II binding groove is open at both ends making the correct alignment of a peptide in the binding groove a crucial part of identifying the core of an MHC class II binding motif. Here, we present a novel stabilization matrix alignment method, SMM-align, that allows for direct prediction of peptide:MHC binding affinities. The predictive performance of the method is validated on a large MHC class II benchmark data set covering 14 HLA-DR (human MHC) and three mouse H2-IA alleles. The predictive performance of the SMM-align method was demonstrated to be superior to that of the Gibbs sampler, TEPITOPE, SVRMHC, and MHCpred methods. Cross validation between peptide data set obtained from different sources demonstrated that direct incorporation of peptide length potentially results in over-fitting of the binding prediction method. Focusing on amino terminal peptide flanking residues (PFR), we demonstrate a consistent gain in predictive performance by favoring binding registers with a minimum PFR length of two amino acids. Visualizing the binding motif as obtained by the SMM-align and TEPITOPE methods highlights a series of fundamental discrepancies between the two predicted motifs. For the DRB1*1302 allele for instance, the TEPITOPE method favors basic amino acids at most anchor positions, whereas the SMM-align method identifies a preference for hydrophobic or neutral amino acids at the anchors. The SMM-align method was shown to outperform other

  19. Prediction of MHC class II binding affinity using SMM-align, a novel stabilization matrix alignment method

    Directory of Open Access Journals (Sweden)

    Lund Ole

    2007-07-01

    Full Text Available Abstract Background Antigen presenting cells (APCs sample the extra cellular space and present peptides from here to T helper cells, which can be activated if the peptides are of foreign origin. The peptides are presented on the surface of the cells in complex with major histocompatibility class II (MHC II molecules. Identification of peptides that bind MHC II molecules is thus a key step in rational vaccine design and developing methods for accurate prediction of the peptide:MHC interactions play a central role in epitope discovery. The MHC class II binding groove is open at both ends making the correct alignment of a peptide in the binding groove a crucial part of identifying the core of an MHC class II binding motif. Here, we present a novel stabilization matrix alignment method, SMM-align, that allows for direct prediction of peptide:MHC binding affinities. The predictive performance of the method is validated on a large MHC class II benchmark data set covering 14 HLA-DR (human MHC and three mouse H2-IA alleles. Results The predictive performance of the SMM-align method was demonstrated to be superior to that of the Gibbs sampler, TEPITOPE, SVRMHC, and MHCpred methods. Cross validation between peptide data set obtained from different sources demonstrated that direct incorporation of peptide length potentially results in over-fitting of the binding prediction method. Focusing on amino terminal peptide flanking residues (PFR, we demonstrate a consistent gain in predictive performance by favoring binding registers with a minimum PFR length of two amino acids. Visualizing the binding motif as obtained by the SMM-align and TEPITOPE methods highlights a series of fundamental discrepancies between the two predicted motifs. For the DRB1*1302 allele for instance, the TEPITOPE method favors basic amino acids at most anchor positions, whereas the SMM-align method identifies a preference for hydrophobic or neutral amino acids at the anchors. Conclusion

  20. Design and fabrication of a eccentric wheels based motorised alignment mechanism for cylindrical accelerator components

    International Nuclear Information System (INIS)

    Mundra, G.; Jain, V.; Karmarkar, Mangesh; Kotaiah, S.

    2006-01-01

    Precision alignment mechanisms with long term stability are required for accelerator components. For some of the components motorised and remotely operable alignment mechanism are required. An eccentric wheel mechanism based alignment system is very much suitable for such application. One such alignment system is designed, a prototype is machined/fabricated for SFDTL type accelerating structure and preliminary trial experiments have been done. (author)

  1. Markov random field based automatic image alignment for electron tomography.

    Science.gov (United States)

    Amat, Fernando; Moussavi, Farshid; Comolli, Luis R; Elidan, Gal; Downing, Kenneth H; Horowitz, Mark

    2008-03-01

    We present a method for automatic full-precision alignment of the images in a tomographic tilt series. Full-precision automatic alignment of cryo electron microscopy images has remained a difficult challenge to date, due to the limited electron dose and low image contrast. These facts lead to poor signal to noise ratio (SNR) in the images, which causes automatic feature trackers to generate errors, even with high contrast gold particles as fiducial features. To enable fully automatic alignment for full-precision reconstructions, we frame the problem probabilistically as finding the most likely particle tracks given a set of noisy images, using contextual information to make the solution more robust to the noise in each image. To solve this maximum likelihood problem, we use Markov Random Fields (MRF) to establish the correspondence of features in alignment and robust optimization for projection model estimation. The resulting algorithm, called Robust Alignment and Projection Estimation for Tomographic Reconstruction, or RAPTOR, has not needed any manual intervention for the difficult datasets we have tried, and has provided sub-pixel alignment that is as good as the manual approach by an expert user. We are able to automatically map complete and partial marker trajectories and thus obtain highly accurate image alignment. Our method has been applied to challenging cryo electron tomographic datasets with low SNR from intact bacterial cells, as well as several plastic section and X-ray datasets.

  2. Automatic laser beam alignment using blob detection for an environment monitoring spectroscopy

    Science.gov (United States)

    Khidir, Jarjees; Chen, Youhua; Anderson, Gary

    2013-05-01

    This paper describes a fully automated system to align an infra-red laser beam with a small retro-reflector over a wide range of distances. The component development and test were especially used for an open-path spectrometer gas detection system. Using blob detection under OpenCV library, an automatic alignment algorithm was designed to achieve fast and accurate target detection in a complex background environment. Test results are presented to show that the proposed algorithm has been successfully applied to various target distances and environment conditions.

  3. ARE TIDAL EFFECTS RESPONSIBLE FOR EXOPLANETARY SPIN–ORBIT ALIGNMENT?

    Energy Technology Data Exchange (ETDEWEB)

    Li, Gongjie [Harvard-Smithsonian Center for Astrophysics, The Institute for Theory and Computation, 60 Garden Street, Cambridge, MA 02138 (United States); Winn, Joshua N., E-mail: gli@cfa.harvard.edu [Department of Physics, Massachusetts Institute of Technology, 77 Massachusetts Avenue, Cambridge, MA 02139 (United States)

    2016-02-10

    The obliquities of planet-hosting stars are clues about the formation of planetary systems. Previous observations led to the hypothesis that for close-in giant planets, spin–orbit alignment is enforced by tidal interactions. Here, we examine two problems with this hypothesis. First, Mazeh and coworkers recently used a new technique—based on the amplitude of starspot-induced photometric variability—to conclude that spin–orbit alignment is common even for relatively long-period planets, which would not be expected if tides were responsible. We re-examine the data and find a statistically significant correlation between photometric variability and planetary orbital period that is qualitatively consistent with tidal interactions. However it is still difficult to explain quantitatively, as it would require tides to be effective for periods as long as tens of days. Second, Rogers and Lin argued against a particular theory for tidal re-alignment by showing that initially retrograde systems would fail to be re-aligned, in contradiction with the observed prevalence of prograde systems. We investigate a simple model that overcomes this problem by taking into account the dissipation of inertial waves and the equilibrium tide, as well as magnetic braking. We identify a region of parameter space where re-alignment can be achieved, but it only works for close-in giant planets, and requires some fine tuning. Thus, while we find both problems to be more nuanced than they first appeared, the tidal model still has serious shortcomings.

  4. Haplotype-Based Genotyping in Polyploids

    Directory of Open Access Journals (Sweden)

    Josh P. Clevenger

    2018-04-01

    Full Text Available Accurate identification of polymorphisms from sequence data is crucial to unlocking the potential of high throughput sequencing for genomics. Single nucleotide polymorphisms (SNPs are difficult to accurately identify in polyploid crops due to the duplicative nature of polyploid genomes leading to low confidence in the true alignment of short reads. Implementing a haplotype-based method in contrasting subgenome-specific sequences leads to higher accuracy of SNP identification in polyploids. To test this method, a large-scale 48K SNP array (Axiom Arachis2 was developed for Arachis hypogaea (peanut, an allotetraploid, in which 1,674 haplotype-based SNPs were included. Results of the array show that 74% of the haplotype-based SNP markers could be validated, which is considerably higher than previous methods used for peanut. The haplotype method has been implemented in a standalone program, HAPLOSWEEP, which takes as input bam files and a vcf file and identifies haplotype-based markers. Haplotype discovery can be made within single reads or span paired reads, and can leverage long read technology by targeting any length of haplotype. Haplotype-based genotyping is applicable in all allopolyploid genomes and provides confidence in marker identification and in silico-based genotyping for polyploid genomics.

  5. 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...

  6. Three-dimensional hindfoot alignment measurements based on biplanar radiographs: comparison with standard radiographic measurements

    International Nuclear Information System (INIS)

    Sutter, Reto; Pfirrmann, Christian W.A.; Buck, Florian M.; Espinosa, Norman

    2013-01-01

    To establish a hindfoot alignment measurement technique based on low-dose biplanar radiographs and compare with hindfoot alignment measurements on long axial view radiographs, which is the current reference standard. Long axial view radiographs and low-dose biplanar radiographs of a phantom consisting of a human foot skeleton embedded in acrylic glass (phantom A) and a plastic model of a human foot in three different hindfoot positions (phantoms B1-B3) were imaged in different foot positions (20 internal to 20 external rotation). Two independent readers measured hindfoot alignment on long axial view radiographs and performed 3D hindfoot alignment measurements based on biplanar radiographs on two different occasions. Time for three-dimensional (3D) measurements was determined. Intraclass correlation coefficients (ICC) were calculated. Hindfoot alignment measurements on long axial view radiographs were characterized by a large positional variation, with a range of 14 /13 valgus to 22 /27 varus (reader 1/2 for phantom A), whereas the range of 3D hindfoot alignment measurements was 7.3 /6.0 to 9.0 /10.5 varus (reader 1/2 for phantom A), with a mean and standard deviation of 8.1 ± 0.6/8.7 ± 1.4 respectively. Interobserver agreement was high (ICC = 0.926 for phantom A, and ICC = 0.886 for phantoms B1-B3), and agreement between different readouts was high (ICC = 0.895-0.995 for reader 1, and ICC = 0.987-0.994 for reader 2) for 3D measurements. Mean duration of 3D measurements was 84 ± 15/113 ± 15 s for reader 1/2. Three-dimensional hindfoot alignment measurements based on biplanar radiographs were independent of foot positioning during image acquisition and reader independent. In this phantom study, the 3D measurements were substantially more precise than the standard radiographic measurements. (orig.)

  7. 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.

  8. CCD Camera Lens Interface for Real-Time Theodolite Alignment

    Science.gov (United States)

    Wake, Shane; Scott, V. Stanley, III

    2012-01-01

    Theodolites are a common instrument in the testing, alignment, and building of various systems ranging from a single optical component to an entire instrument. They provide a precise way to measure horizontal and vertical angles. They can be used to align multiple objects in a desired way at specific angles. They can also be used to reference a specific location or orientation of an object that has moved. Some systems may require a small margin of error in position of components. A theodolite can assist with accurately measuring and/or minimizing that error. The technology is an adapter for a CCD camera with lens to attach to a Leica Wild T3000 Theodolite eyepiece that enables viewing on a connected monitor, and thus can be utilized with multiple theodolites simultaneously. This technology removes a substantial part of human error by relying on the CCD camera and monitors. It also allows image recording of the alignment, and therefore provides a quantitative means to measure such error.

  9. Hidden Language Impairments in Children: Parallels between Poor Reading Comprehension and Specific Language Impairment?

    Science.gov (United States)

    Nation, Kate; Clarke, Paula; Marshall, Catherine M.; Durand, Marianne

    2004-01-01

    This study investigates the oral language skills of 8-year-old children with impaired reading comprehension. Despite fluent and accurate reading and normal nonverbal ability, these children are poor at understanding what they have read. Tasks tapping 3 domains of oral language, namely phonology, semantics, and morphosyntax, were administered,…

  10. Xylem vulnerability to cavitation can be accurately characterised in species with long vessels using a centrifuge method.

    Science.gov (United States)

    Tobin, M F; Pratt, R B; Jacobsen, A L; De Guzman, M E

    2013-05-01

    Vulnerability to cavitation curves describe the decrease in xylem hydraulic conductivity as xylem pressure declines. Several techniques for constructing vulnerability curves use centrifugal force to induce negative xylem pressure in stem or root segments. Centrifuge vulnerability curves constructed for long-vesselled species have been hypothesised to overestimate xylem vulnerability to cavitation due to increased vulnerability of vessels cut open at stem ends that extend to the middle or entirely through segments. We tested two key predictions of this hypothesis: (i) centrifugation induces greater embolism than dehydration in long-vesselled species, and (ii) the proportion of open vessels changes centrifuge vulnerability curves. Centrifuge and dehydration vulnerability curves were compared for a long- and short-vesselled species. The effect of open vessels was tested in four species by comparing centrifuge vulnerability curves for stems of two lengths. Centrifuge and dehydration vulnerability curves agreed well for the long- and short-vesselled species. Centrifuge vulnerability curves constructed using two stem lengths were similar. Also, the distribution of embolism along the length of centrifuged stems matched the theoretical pressure profile induced by centrifugation. We conclude that vulnerability to cavitation can be accurately characterised with vulnerability curves constructed using a centrifuge technique, even in long-vesselled species. © 2012 German Botanical Society and The Royal Botanical Society of the Netherlands.

  11. A Long-Read Transcriptome Assembly of Cotton (Gossypium hirsutum L. and Intraspecific Single Nucleotide Polymorphism Discovery

    Directory of Open Access Journals (Sweden)

    Hamid Ashrafi

    2015-07-01

    Full Text Available Upland cotton ( L. has a narrow germplasm base, which constrains marker development and hampers intraspecific breeding. A pressing need exists for high-throughput single nucleotide polymorphism (SNP markers that can be readily applied to germplasm in breeding and breeding-related research programs. Despite progress made in developing new sequencing technologies during the past decade, the cost of sequencing remains substantial when one is dealing with numerous samples and large genomes. Several strategies have been proposed to lower the cost of sequencing for multiple genotypes of large-genome species like cotton, such as transcriptome sequencing and reduced-representation DNA sequencing. This paper reports the development of a transcriptome assembly of the inbred line Texas Marker-1 (TM-1, a genetic standard for cotton, its usefulness as a reference for RNA sequencing (RNA-seq-based SNP identification, and the availability of transcriptome sequences of four other cotton cultivars. An assembly of TM-1 was made using Roche 454 transcriptome reads combined with an assembly of all available public expressed sequence tag (EST sequences of TM-1. The TM-1 assembly consists of 72,450 contigs with a total of 70 million bp. Functional predictions of the transcripts were estimated by alignment to selected protein databases. Transcriptome sequences of the five lines, including TM-1, were obtained using an Illumina Genome Analyzer-II, and the short reads were mapped to the TM-1 assembly to discover SNPs among the five lines. We identified >14,000 unfiltered allelic SNPs, of which ∼3,700 SNPs were retained for assay development after applying several rigorous filters. This paper reports availability of the reference transcriptome assembly and shows its utility in developing intraspecific SNP markers in upland cotton.

  12. Dyslexie font does not benefit reading in children with or without dyslexia

    NARCIS (Netherlands)

    Kuster, S.M.; Weerdenburg, M.W.C. van; Gompel, M.; Bosman, A.M.T.

    2018-01-01

    In two experiments, the claim was tested that the font "Dyslexie", specifically designed for people with dyslexia, eases reading performance of children with (and without) dyslexia. Three questions were investigated. (1) Does the Dyslexie font lead to faster and/or more accurate reading? (2) Do

  13. Alignment of high-throughput sequencing data inside in-memory databases.

    Science.gov (United States)

    Firnkorn, Daniel; Knaup-Gregori, Petra; Lorenzo Bermejo, Justo; Ganzinger, Matthias

    2014-01-01

    In times of high-throughput DNA sequencing techniques, performance-capable analysis of DNA sequences is of high importance. Computer supported DNA analysis is still an intensive time-consuming task. In this paper we explore the potential of a new In-Memory database technology by using SAP's High Performance Analytic Appliance (HANA). We focus on read alignment as one of the first steps in DNA sequence analysis. In particular, we examined the widely used Burrows-Wheeler Aligner (BWA) and implemented stored procedures in both, HANA and the free database system MySQL, to compare execution time and memory management. To ensure that the results are comparable, MySQL has been running in memory as well, utilizing its integrated memory engine for database table creation. We implemented stored procedures, containing exact and inexact searching of DNA reads within the reference genome GRCh37. Due to technical restrictions in SAP HANA concerning recursion, the inexact matching problem could not be implemented on this platform. Hence, performance analysis between HANA and MySQL was made by comparing the execution time of the exact search procedures. Here, HANA was approximately 27 times faster than MySQL which means, that there is a high potential within the new In-Memory concepts, leading to further developments of DNA analysis procedures in the future.

  14. Value Systems Alignment Analysis in Collaborative Networked Organizations Management

    OpenAIRE

    Patricia Macedo; Luis Camarinha-Matos

    2017-01-01

    The assessment of value systems alignment can play an important role in the formation and evolution of collaborative networks, contributing to reduce potential risks of collaboration. For this purpose, an assessment tool is proposed as part of a collaborative networks information system, supporting both the formation and evolution of long-term strategic alliances and goal-oriented networks. An implementation approach for value system alignment analysis is described, which is intended to assis...

  15. Functionalization of vertically aligned carbon nanotubes

    Directory of Open Access Journals (Sweden)

    Eloise Van Hooijdonk

    2013-02-01

    Full Text Available This review focuses and summarizes recent studies on the functionalization of carbon nanotubes oriented perpendicularly to their substrate, so-called vertically aligned carbon nanotubes (VA-CNTs. The intrinsic properties of individual nanotubes make the VA-CNTs ideal candidates for integration in a wide range of devices, and many potential applications have been envisaged. These applications can benefit from the unidirectional alignment of the nanotubes, the large surface area, the high carbon purity, the outstanding electrical conductivity, and the uniformly long length. However, practical uses of VA-CNTs are limited by their surface characteristics, which must be often modified in order to meet the specificity of each particular application. The proposed approaches are based on the chemical modifications of the surface by functionalization (grafting of functional chemical groups, decoration with metal particles or wrapping of polymers to bring new properties or to improve the interactions between the VA-CNTs and their environment while maintaining the alignment of CNTs.

  16. Functionalization of vertically aligned carbon nanotubes.

    Science.gov (United States)

    Van Hooijdonk, Eloise; Bittencourt, Carla; Snyders, Rony; Colomer, Jean-François

    2013-01-01

    This review focuses and summarizes recent studies on the functionalization of carbon nanotubes oriented perpendicularly to their substrate, so-called vertically aligned carbon nanotubes (VA-CNTs). The intrinsic properties of individual nanotubes make the VA-CNTs ideal candidates for integration in a wide range of devices, and many potential applications have been envisaged. These applications can benefit from the unidirectional alignment of the nanotubes, the large surface area, the high carbon purity, the outstanding electrical conductivity, and the uniformly long length. However, practical uses of VA-CNTs are limited by their surface characteristics, which must be often modified in order to meet the specificity of each particular application. The proposed approaches are based on the chemical modifications of the surface by functionalization (grafting of functional chemical groups, decoration with metal particles or wrapping of polymers) to bring new properties or to improve the interactions between the VA-CNTs and their environment while maintaining the alignment of CNTs.

  17. Comparison of Forced-Alignment Speech Recognition and Humans for Generating Reference VAD

    DEFF Research Database (Denmark)

    Kraljevski, Ivan; Tan, Zheng-Hua; Paola Bissiri, Maria

    2015-01-01

    This present paper aims to answer the question whether forced-alignment speech recognition can be used as an alternative to humans in generating reference Voice Activity Detection (VAD) transcriptions. An investigation of the level of agreement between automatic/manual VAD transcriptions and the ......This present paper aims to answer the question whether forced-alignment speech recognition can be used as an alternative to humans in generating reference Voice Activity Detection (VAD) transcriptions. An investigation of the level of agreement between automatic/manual VAD transcriptions...... and the reference ones produced by a human expert was carried out. Thereafter, statistical analysis was employed on the automatically produced and the collected manual transcriptions. Experimental results confirmed that forced-alignment speech recognition can provide accurate and consistent VAD labels....

  18. 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.

  19. Considerations in the identification of functional RNA structural elements in genomic alignments

    Directory of Open Access Journals (Sweden)

    Blencowe Benjamin J

    2007-01-01

    Full Text Available Abstract Background Accurate identification of novel, functional noncoding (nc RNA features in genome sequence has proven more difficult than for exons. Current algorithms identify and score potential RNA secondary structures on the basis of thermodynamic stability, conservation, and/or covariance in sequence alignments. Neither the algorithms nor the information gained from the individual inputs have been independently assessed. Furthermore, due to issues in modelling background signal, it has been difficult to gauge the precision of these algorithms on a genomic scale, in which even a seemingly small false-positive rate can result in a vast excess of false discoveries. Results We developed a shuffling algorithm, shuffle-pair.pl, that simultaneously preserves dinucleotide frequency, gaps, and local conservation in pairwise sequence alignments. We used shuffle-pair.pl to assess precision and recall of six ncRNA search tools (MSARI, QRNA, ddbRNA, RNAz, Evofold, and several variants of simple thermodynamic stability on a test set of 3046 alignments of known ncRNAs. Relative to mononucleotide shuffling, preservation of dinucleotide content in shuffling the alignments resulted in a drastic increase in estimated false-positive detection rates for ncRNA elements, precluding evaluation of higher order alignments, which cannot not be adequately shuffled maintaining both dinucleotides and alignment structure. On pairwise alignments, none of the covariance-based tools performed markedly better than thermodynamic scoring alone. Although the high false-positive rates call into question the veracity of any individual predicted secondary structural element in our analysis, we nevertheless identified intriguing global trends in human genome alignments. The distribution of ncRNA prediction scores in 75-base windows overlapping UTRs, introns, and intergenic regions analyzed using both thermodynamic stability and EvoFold (which has no thermodynamic component was

  20. 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.

  1. Phonological and Non-Phonological Language Skills as Predictors of Early Reading Performance

    Science.gov (United States)

    Batson-Magnuson, LuAnn

    2010-01-01

    Accurate prediction of early childhood reading performance could help identify at-risk students, aid in the development of evidence-based intervention strategies, and further our theoretical understanding of reading development. This study assessed the validity of the Developmental Indicator for the Assessment of Learning (DIAL) language-based…

  2. 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, ...

  3. Working memory influences processing speed and reading fluency in ADHD.

    Science.gov (United States)

    Jacobson, Lisa A; Ryan, Matthew; Martin, Rebecca B; Ewen, Joshua; Mostofsky, Stewart H; Denckla, Martha B; Mahone, E Mark

    2011-01-01

    Processing-speed deficits affect reading efficiency, even among individuals who recognize and decode words accurately. Children with ADHD who decode words accurately can still have inefficient reading fluency, leading to a bottleneck in other cognitive processes. This "slowing" in ADHD is associated with deficits in fundamental components of executive function underlying processing speed, including response selection. The purpose of the present study was to deconstruct processing speed in order to determine which components of executive control best explain the "processing" speed deficits related to reading fluency in ADHD. Participants (41 ADHD, 21 controls), ages 9-14 years, screened for language disorders, word reading deficits, and psychiatric disorders, were administered measures of copying speed, processing speed, reading fluency, working memory, reaction time, inhibition, and auditory attention span. Compared to controls, children with ADHD showed reduced oral and silent reading fluency and reduced processing speed-driven primarily by deficits on WISC-IV Coding. In contrast, groups did not differ on copying speed. After controlling for copying speed, sex, severity of ADHD-related symptomatology, and GAI, slowed "processing" speed (i.e., Coding) was significantly associated with verbal span and measures of working memory but not with measures of response control/inhibition, lexical retrieval speed, reaction time, or intrasubject variability. Further, "processing" speed (i.e., Coding, residualized for copying speed) and working memory were significant predictors of oral reading fluency. Abnormalities in working memory and response selection (which are frontally mediated and enter into the output side of processing speed) may play an important role in deficits in reading fluency in ADHD, potentially more than posteriorally mediated problems with orienting of attention or perceiving the stimulus.

  4. Reading, Writing & Rings: Science Literacy for K-4 Students

    Science.gov (United States)

    McConnell, S.; Spilker, L.; Zimmerman-Brachman, R.

    2007-12-01

    Scientific discovery is the impetus for the K-4 Education program, "Reading, Writing & Rings." This program is unique because its focus is to engage elementary students in reading and writing to strengthen these basic academic skills through scientific content. As science has been increasingly overtaken by the language arts in elementary classrooms, the Cassini Education Program has taken advantage of a new cross-disciplinary approach to use language arts as a vehicle for increasing scientific content in the classroom. By utilizing the planet Saturn and the Cassini-Huygens mission as a model in both primary reading and writing students in these grade levels, young students can explore science material while at the same time learning these basic academic skills. Content includes reading, thinking, and hands-on activities. Developed in partnership with the Cassini-Huygens Education and Public Outreach Program, the Bay Area Writing Project/California Writing Project, Foundations in Reading Through Science & Technology (FIRST), and the Caltech Pre-College Science Initiative (CAPSI), and classroom educators, "Reading, Writing & Rings" blends the excitement of space exploration with reading and writing. All materials are teacher developed, aligned with national science and language education standards, and are available from the Cassini-Huygens website: http://saturn.jpl.nasa.gov/education/edu-k4.cfm Materials are divided into two grade level units. One unit is designed for students in grades 1 and 2 while the other unit focuses on students in grades 3 and 4. Each includes a series of lessons that take students on a path of exploration of Saturn using reading and writing prompts.

  5. Identifying Children in Middle Childhood Who Are at Risk for Reading Problems.

    Science.gov (United States)

    Speece, Deborah L; Ritchey, Kristen D; Silverman, Rebecca; Schatschneider, Christopher; Walker, Caroline Y; Andrusik, Katryna N

    2010-06-01

    The purpose of this study was to identify and evaluate a universal screening battery for reading that is appropriate for older elementary students in a response to intervention model. Multiple measures of reading and reading correlates were administered to 230 fourth-grade children. Teachers rated children's reading skills, academic competence, and attention. Children were classified as not-at-risk or at-risk readers based on a three-factor model reflecting reading comprehension, word recognition/decoding, and word fluency. Predictors of reading status included group-administered tests of reading comprehension, silent word reading fluency, and teacher ratings of reading problems. Inclusion of individually administered tests and growth estimates did not add substantial variance. The receiver-operator characteristic curve analysis yielded an area under the curve index of 0.90, suggesting this model may both accurately and efficiently screen older elementary students with reading problems.

  6. 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...

  7. SU-F-I-59: Quality Assurance Phantom for PET/CT Alignment and Attenuation Correction

    International Nuclear Information System (INIS)

    Lin, T; Hamacher, K

    2016-01-01

    Purpose: This study utilizes a commercial PET/CT phantom to investigate two specific properties of a PET/CT system: the alignment accuracy of PET images with those from CT used for attenuation correction and the accuracy of this correction in PET images. Methods: A commercial PET/CT phantom consisting of three aluminum rods, two long central cylinders containing uniform activity, and attenuating materials such as air, water, bone and iodine contrast was scanned using a standard PET/CT protocol. Images reconstructed with 2 mm slice thickness and a 512 by 512 matrix were obtained. The center of each aluminum rod in the PET and CT images was compared to evaluate alignment accuracy. ROIs were drawn on transaxial images of the central rods at each section of attenuating material to determine the corrected activity (in BQML). BQML values were graphed as a function of slice number to provide a visual representation of the attenuation-correction throughout the whole phantom. Results: Alignment accuracy is high between the PET and CT images. The maximum deviation between the two in the axial plane is less than 1.5 mm, which is less than the width of a single pixel. BQML values measured along different sections of the large central rods are similar among the different attenuating materials except iodine contrast. Deviation of BQML values in the air and bone sections from the water section is less than 1%. Conclusion: Accurate alignment of PET and CT images is critical to ensure proper calculation and application of CT-based attenuation correction. This study presents a simple and quick method to evaluate the two with a single acquisition. As the phantom also includes spheres of increasing diameter, this could serve as a straightforward means to annually evaluate the status of a modern PET/CT system.

  8. SU-F-I-59: Quality Assurance Phantom for PET/CT Alignment and Attenuation Correction

    Energy Technology Data Exchange (ETDEWEB)

    Lin, T; Hamacher, K [Columbia University Medical Center, New York, NY (United States)

    2016-06-15

    Purpose: This study utilizes a commercial PET/CT phantom to investigate two specific properties of a PET/CT system: the alignment accuracy of PET images with those from CT used for attenuation correction and the accuracy of this correction in PET images. Methods: A commercial PET/CT phantom consisting of three aluminum rods, two long central cylinders containing uniform activity, and attenuating materials such as air, water, bone and iodine contrast was scanned using a standard PET/CT protocol. Images reconstructed with 2 mm slice thickness and a 512 by 512 matrix were obtained. The center of each aluminum rod in the PET and CT images was compared to evaluate alignment accuracy. ROIs were drawn on transaxial images of the central rods at each section of attenuating material to determine the corrected activity (in BQML). BQML values were graphed as a function of slice number to provide a visual representation of the attenuation-correction throughout the whole phantom. Results: Alignment accuracy is high between the PET and CT images. The maximum deviation between the two in the axial plane is less than 1.5 mm, which is less than the width of a single pixel. BQML values measured along different sections of the large central rods are similar among the different attenuating materials except iodine contrast. Deviation of BQML values in the air and bone sections from the water section is less than 1%. Conclusion: Accurate alignment of PET and CT images is critical to ensure proper calculation and application of CT-based attenuation correction. This study presents a simple and quick method to evaluate the two with a single acquisition. As the phantom also includes spheres of increasing diameter, this could serve as a straightforward means to annually evaluate the status of a modern PET/CT system.

  9. Evaluation of GMI and PMI diffeomorphic-based demons algorithms for aligning PET and CT Images.

    Science.gov (United States)

    Yang, Juan; Wang, Hongjun; Zhang, You; Yin, Yong

    2015-07-08

    Fusion of anatomic information in computed tomography (CT) and functional information in 18F-FDG positron emission tomography (PET) is crucial for accurate differentiation of tumor from benign masses, designing radiotherapy treatment plan and staging of cancer. Although current PET and CT images can be acquired from combined 18F-FDG PET/CT scanner, the two acquisitions are scanned separately and take a long time, which may induce potential positional errors in global and local caused by respiratory motion or organ peristalsis. So registration (alignment) of whole-body PET and CT images is a prerequisite for their meaningful fusion. The purpose of this study was to assess the performance of two multimodal registration algorithms for aligning PET and CT images. The proposed gradient of mutual information (GMI)-based demons algorithm, which incorporated the GMI between two images as an external force to facilitate the alignment, was compared with the point-wise mutual information (PMI) diffeomorphic-based demons algorithm whose external force was modified by replacing the image intensity difference in diffeomorphic demons algorithm with the PMI to make it appropriate for multimodal image registration. Eight patients with esophageal cancer(s) were enrolled in this IRB-approved study. Whole-body PET and CT images were acquired from a combined 18F-FDG PET/CT scanner for each patient. The modified Hausdorff distance (d(MH)) was used to evaluate the registration accuracy of the two algorithms. Of all patients, the mean values and standard deviations (SDs) of d(MH) were 6.65 (± 1.90) voxels and 6.01 (± 1.90) after the GMI-based demons and the PMI diffeomorphic-based demons registration algorithms respectively. Preliminary results on oncological patients showed that the respiratory motion and organ peristalsis in PET/CT esophageal images could not be neglected, although a combined 18F-FDG PET/CT scanner was used for image acquisition. The PMI diffeomorphic-based demons

  10. Foreign Language Reading and Spelling in Gifted Students with Dyslexia in Secondary Education

    Science.gov (United States)

    van Viersen, Sietske; de Bree, Elise H.; Kalee, Lilian; Kroesbergen, Evelyn H.; de Jong, Peter F.

    2017-01-01

    A few studies suggest that gifted children with dyslexia have better literacy skills than averagely intelligent children with dyslexia. This finding aligns with the hypothesis that giftedness-related factors provide compensation for poor reading. The present study investigated whether, as in the native language (NL), the level of foreign language…

  11. Effects of working memory and reading acceleration training on improving working memory abilities and reading skills among third graders.

    Science.gov (United States)

    Nevo, Einat; Breznitz, Zvia

    2014-01-01

    Working memory (WM) plays a crucial role in supporting learning, including reading. This study investigated the influence of reading acceleration and WM training programs on improving reading skills and WM abilities. Ninety-seven children in third grade were divided into three study groups and one control group. The three study groups each received a different combination of two training programs: only reading acceleration, WM followed by reading acceleration, and reading acceleration followed by WM. All training programs significantly improved reading skills and WM abilities. Compared with the control group, the group trained with only the reading acceleration program improved word accuracy, whereas the groups trained with a combination of reading and WM programs improved word and pseudo-word fluency. The reading-acceleration-alone group and the WM-program-followed-by-reading-acceleration group improved phonological complex memory. We conclude that a training program that combines a long reading acceleration program and a short WM program is the most effective for improving the abilities most related to scholastic achievement.

  12. Basic Concepts of Reading Instruction

    Directory of Open Access Journals (Sweden)

    Gökhan ARI

    2017-12-01

    Full Text Available Reading act is performed by connected physiological, psychological and cognitive processes. The operations taking place in these processes are expected to continue for life by being developed with certain strategies. A lot of information is gained with reading skill in education life. Therefore, basic concepts that constitute reading education in teaching and improving reading are important for teachers. The aim of this study is to submit information compiled from the literature about reading education process and which basic concepts are used in reading education. While teaching reading from part to whole, from whole to part and interactional approaches are used. From part to whole approach is at the forefront. Then with interactional approach strategies, both code solving and making sense is improved. Teachers should know the characteristics of bouncing, stopping, turning back, and scanning movements of the eye both in code solving and making sense. The teacher should configure the teaching for the students to gain fluid reading elements by making use of reading out and reading silently. After reading act is acquired; good reader characteristics should be gained by improving asking questions, guessing, summarizing, interpretation skills in integrated readings. Reading skill is improved by studies on the text. Therefore, the students should come across texts that are suitable to their levels, textuality and readability criteria. The vocabulary of children should be improved in a planned way with text-based word and meaning studies. Fluid reading, making sense and interpretation skills of children should be pursued with different evaluation types. In the long term, work should be done to make reading a habit for them.

  13. Long-term prediction of reading accuracy and speed: The importance of paired-associate learning

    DEFF Research Database (Denmark)

    Poulsen, Mads; Asmussen, Vibeke; Elbro, Carsten

    Purpose: Several cross-sectional studies have found a correlation between paired-associate learning (PAL) and reading (e.g. Litt et al., 2013; Messbauer & de Jong, 2003, 2006). These findings suggest that verbal learning of phonological forms is important for reading. However, results from...... longitudinal studies have been mixed (e.g. Lervåg & Hulme, 2009; Horbach et al. 2015). The present study investigated the possibility that the mixed results may be a result of a conflation of accuracy and speed. It is possible that PAL is a stronger correlate of reading accuracy than speed (Litt et al., 2013...... of reading comprehension and isolated sight word reading accuracy and speed. Results: PAL predicted unique variance in sight word accuracy, but not speed. Furthermore, PAL was indirectly linked to reading comprehension through sight word accuracy. RAN correlated with both accuracy and speed...

  14. Fast evaluation of patient set-up during radiotherapy by aligning features in portal and simulator images

    International Nuclear Information System (INIS)

    Bijhold, J.; Herk, M. van; Vijlbrief, R.; Lebesque, J.V.

    1991-01-01

    A new fast method is presented for the quantification of patient set-up errors during radiotherapy with external photon beams. The set-up errors are described as deviations in relative position and orientation of specified anatomical structures relative to specified field shaping devices. These deviations are determined from parameters of the image transformations that make their features in a portal image align with the corresponding features in a simulator image. Knowledge of some set-up parameters during treatment simulation is required. The method does not require accurate knowledge about the position of the portal imaging device as long as the positions of some of the field shaping devices are verified independently during treatment. By applying this method, deviations in a pelvic phantom set-up can be measured with a precision of 2 mm within 1 minute. Theoretical considerations and experiments have shown that the method is not applicable when there are out-of-plane rotations larger than 2 degrees or translations larger than 1 cm. Inter-observer variability proved to be a source of large systematic errors, which could be reduced by offering a precise protocol for the feature alignment. (author)

  15. Calibration, alignment and long-term performance of the CMS silicon tracking detector

    International Nuclear Information System (INIS)

    Butz, E.

    2009-03-01

    identified and monitored. The total amount of localized and non-localized defects is found to be about 0.7% for the two end cap sectors. Lastly, the alignment of the detector is a subject of interest, as the exact alignment of all components of the tracker with respect to each other will be of prime importance for any analysis using the tracker. The separation of primary and secondary vertices as well as the momentum resolution depend largely on a very good alignment of the detector. In this thesis, the validation of an alignment result is investigated. Several quantities which could be used to judge the quality of an alignment are discussed. A first application of the validation is shown on cosmic muon data, taken with the whole silicon tracker after the integration into the experiment. (orig.)

  16. Calibration, alignment and long-term performance of the CMS silicon tracking detector

    Energy Technology Data Exchange (ETDEWEB)

    Butz, E.

    2009-03-15

    defects are identified and monitored. The total amount of localized and non-localized defects is found to be about 0.7% for the two end cap sectors. Lastly, the alignment of the detector is a subject of interest, as the exact alignment of all components of the tracker with respect to each other will be of prime importance for any analysis using the tracker. The separation of primary and secondary vertices as well as the momentum resolution depend largely on a very good alignment of the detector. In this thesis, the validation of an alignment result is investigated. Several quantities which could be used to judge the quality of an alignment are discussed. A first application of the validation is shown on cosmic muon data, taken with the whole silicon tracker after the integration into the experiment. (orig.)

  17. Alignment of symmetric top molecules by short laser pulses

    DEFF Research Database (Denmark)

    Hamilton, Edward; Seideman, Tamar; Ejdrup, Tine

    2005-01-01

    -resolved photofragment imaging. Using methyliodide and tert-butyliodide as examples, we calculate and measure the alignment dynamics, focusing on the temporal structure and intensity of the revival patterns, including their dependence on the pulse duration, and their behavior at long times, where centrifugal distortion......Nonadiabatic alignment of symmetric top molecules induced by a linearly polarized, moderately intense picosecond laser pulse is studied theoretically and experimentally. Our studies are based on the combination of a nonperturbative solution of the Schrodinger equation with femtosecond time...

  18. The SOAPS project – Spin-orbit alignment of planetary systems

    Directory of Open Access Journals (Sweden)

    Hebb L.

    2013-04-01

    Full Text Available The wealth of information rendered by Kepler planets and planet candidates is indispensable for statistically significant studies of distinct planet populations, in both single and multiple systems. Empirical evidences suggest that Kepler's planet population shows different physical properties as compared to the bulk of known exoplanets. The SOAPS project, aims to shed light on Kepler's planets formation, their migration and architecture. By measuring v sini accurately for Kepler hosts with rotation periods measured from their high-precision light curves, we will assess the alignment of the planetary orbit with respect to the stellar spin axis. This degree of alignment traces the formation history and evolution of the planetary systems, and thus, allows to distinguish between different proposed migration theories. SOAPS will increase by a factor of 2 the number of spin-orbit alignment measurements pushing the parameters space down to the SuperEarth domain. Here we present our preliminary results.

  19. Reading Profiles in Multi-Site Data With Missingness.

    Science.gov (United States)

    Eckert, Mark A; Vaden, Kenneth I; Gebregziabher, Mulugeta

    2018-01-01

    Children with reading disability exhibit varied deficits in reading and cognitive abilities that contribute to their reading comprehension problems. Some children exhibit primary deficits in phonological processing, while others can exhibit deficits in oral language and executive functions that affect comprehension. This behavioral heterogeneity is problematic when missing data prevent the characterization of different reading profiles, which often occurs in retrospective data sharing initiatives without coordinated data collection. Here we show that reading profiles can be reliably identified based on Random Forest classification of incomplete behavioral datasets, after the missForest method is used to multiply impute missing values. Results from simulation analyses showed that reading profiles could be accurately classified across degrees of missingness (e.g., ∼5% classification error for 30% missingness across the sample). The application of missForest to a real multi-site dataset with missingness ( n = 924) showed that reading disability profiles significantly and consistently differed in reading and cognitive abilities for cases with and without missing data. The results of validation analyses indicated that the reading profiles (cases with and without missing data) exhibited significant differences for an independent set of behavioral variables that were not used to classify reading profiles. Together, the results show how multiple imputation can be applied to the classification of cases with missing data and can increase the integrity of results from multi-site open access datasets.

  20. Reading Profiles in Multi-Site Data With Missingness

    Directory of Open Access Journals (Sweden)

    Mark A. Eckert

    2018-05-01

    Full Text Available Children with reading disability exhibit varied deficits in reading and cognitive abilities that contribute to their reading comprehension problems. Some children exhibit primary deficits in phonological processing, while others can exhibit deficits in oral language and executive functions that affect comprehension. This behavioral heterogeneity is problematic when missing data prevent the characterization of different reading profiles, which often occurs in retrospective data sharing initiatives without coordinated data collection. Here we show that reading profiles can be reliably identified based on Random Forest classification of incomplete behavioral datasets, after the missForest method is used to multiply impute missing values. Results from simulation analyses showed that reading profiles could be accurately classified across degrees of missingness (e.g., ∼5% classification error for 30% missingness across the sample. The application of missForest to a real multi-site dataset with missingness (n = 924 showed that reading disability profiles significantly and consistently differed in reading and cognitive abilities for cases with and without missing data. The results of validation analyses indicated that the reading profiles (cases with and without missing data exhibited significant differences for an independent set of behavioral variables that were not used to classify reading profiles. Together, the results show how multiple imputation can be applied to the classification of cases with missing data and can increase the integrity of results from multi-site open access datasets.

  1. A novel micromachined shadow mask system with self-alignment and gap control capability

    International Nuclear Information System (INIS)

    Hong, Jung Moo; Zou Jun

    2008-01-01

    We present a novel micromachined shadow mask system, which is capable of accurate self-alignment and mask-substrate gap control. The shadow mask system consists of a silicon shadow mask and a silicon carrier wafer with pyramidal cavities fabricated with bulk micromachining. Self-alignment and gap control of the shadow mask and the fabrication substrate can readily be achieved by using matching pairs of pyramidal cavities and steel spheres placed between. The layer-to-layer alignment accuracy of the new shadow mask system has been experimentally characterized and verified using both optical and atomic force microscopic measurements. As an application of this new shadow mask system, an organic thin-film transistor (OTFT) using pentacene as the semiconductor layer has been successfully fabricated and tested

  2. A Python object-oriented framework for the CMS alignment and calibration data

    Science.gov (United States)

    Dawes, Joshua H.; CMS Collaboration

    2017-10-01

    The Alignment, Calibrations and Databases group at the CMS Experiment delivers Alignment and Calibration Conditions Data to a large set of workflows which process recorded event data and produce simulated events. The current infrastructure for releasing and consuming Conditions Data was designed in the two years of the first LHC long shutdown to respond to use cases from the preceding data-taking period. During the second run of the LHC, new use cases were defined. For the consumption of Conditions Metadata, no common interface existed for the detector experts to use in Python-based custom scripts, resulting in many different querying and transaction management patterns. A new framework has been built to address such use cases: a simple object-oriented tool that detector experts can use to read and write Conditions Metadata when using Oracle and SQLite databases, that provides a homogeneous method of querying across all services. The tool provides mechanisms for segmenting large sets of conditions while releasing them to the production database, allows for uniform error reporting to the client-side from the server-side and optimizes the data transfer to the server. The architecture of the new service has been developed exploiting many of the features made available by the metadata consumption framework to implement the required improvements. This paper presents the details of the design and implementation of the new metadata consumption and data upload framework, as well as analyses of the new upload service’s performance as the server-side state varies.

  3. Improving model construction of profile HMMs for remote homology detection through structural alignment

    Directory of Open Access Journals (Sweden)

    Zaverucha Gerson

    2007-11-01

    Full Text Available Abstract Background Remote homology detection is a challenging problem in Bioinformatics. Arguably, profile Hidden Markov Models (pHMMs are one of the most successful approaches in addressing this important problem. pHMM packages present a relatively small computational cost, and perform particularly well at recognizing remote homologies. This raises the question of whether structural alignments could impact the performance of pHMMs trained from proteins in the Twilight Zone, as structural alignments are often more accurate than sequence alignments at identifying motifs and functional residues. Next, we assess the impact of using structural alignments in pHMM performance. Results We used the SCOP database to perform our experiments. Structural alignments were obtained using the 3DCOFFEE and MAMMOTH-mult tools; sequence alignments were obtained using CLUSTALW, TCOFFEE, MAFFT and PROBCONS. We performed leave-one-family-out cross-validation over super-families. Performance was evaluated through ROC curves and paired two tailed t-test. Conclusion We observed that pHMMs derived from structural alignments performed significantly better than pHMMs derived from sequence alignment in low-identity regions, mainly below 20%. We believe this is because structural alignment tools are better at focusing on the important patterns that are more often conserved through evolution, resulting in higher quality pHMMs. On the other hand, sensitivity of these tools is still quite low for these low-identity regions. Our results suggest a number of possible directions for improvements in this area.

  4. Improving model construction of profile HMMs for remote homology detection through structural alignment.

    Science.gov (United States)

    Bernardes, Juliana S; Dávila, Alberto M R; Costa, Vítor S; Zaverucha, Gerson

    2007-11-09

    Remote homology detection is a challenging problem in Bioinformatics. Arguably, profile Hidden Markov Models (pHMMs) are one of the most successful approaches in addressing this important problem. pHMM packages present a relatively small computational cost, and perform particularly well at recognizing remote homologies. This raises the question of whether structural alignments could impact the performance of pHMMs trained from proteins in the Twilight Zone, as structural alignments are often more accurate than sequence alignments at identifying motifs and functional residues. Next, we assess the impact of using structural alignments in pHMM performance. We used the SCOP database to perform our experiments. Structural alignments were obtained using the 3DCOFFEE and MAMMOTH-mult tools; sequence alignments were obtained using CLUSTALW, TCOFFEE, MAFFT and PROBCONS. We performed leave-one-family-out cross-validation over super-families. Performance was evaluated through ROC curves and paired two tailed t-test. We observed that pHMMs derived from structural alignments performed significantly better than pHMMs derived from sequence alignment in low-identity regions, mainly below 20%. We believe this is because structural alignment tools are better at focusing on the important patterns that are more often conserved through evolution, resulting in higher quality pHMMs. On the other hand, sensitivity of these tools is still quite low for these low-identity regions. Our results suggest a number of possible directions for improvements in this area.

  5. 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.

  6. 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...

  7. Improving Reading Comprehension Skills through Reading Strategies Used by a Group of Foreign Language Learners

    Directory of Open Access Journals (Sweden)

    Nancy Gómez Torres

    2009-12-01

    Full Text Available A research study included the examination and implementation of a variety of strategies in order to improve students’ reading comprehension skills in a foreign language. Reading is the process of identification, interpretation and perception of written or printed material. Comprehension is the understanding of the meaning of written material and involves the conscious strategies that lead to understanding. The reading strategies are conscious techniques or unconscious processes employed by readers in their attempt to make sense of the written text (Barnett as cited by Gascoigne, 2005. Thus, the main goal of this piece of research was to implement some reading strategies in 2 elementary courses in EFL in order to obtain better results in the middle and long term in class and on ECAES, MICHIGAN, MELICET and PET tests.

  8. 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.

  9. Rotational Mal-Alignment after Reamed Intramedullary Nailing for tibial shaft fracture.

    Science.gov (United States)

    Khan, Sher Baz; Mohib, Yasir; Rashid, Rizwan Haroon; Rashid, Haroonur

    2016-10-01

    Intra-medullary (IM) nailing is standard of care for unstable tibial shaft fractures. Malrotation is very common but it is under-recognised, inpart because of variation in normal anatomy and partly due to difficulty in accurately assessing rotation. This study was planned to evaluate the frequency of rotational mal-alignment after reamed tibia IMnailing. This cross-sectional study was conducted at Aga khan University Hospital, Karachi, and comprised patients with tibia shaft fractures managed with IMnailing from January to December 2014. All the patients were assessed intra-operatively for rotational alignment using the knee and ankle fluoroscopic images. There were 81 patients with a mean age of 38±16.9 years. There were 64(79%) male patients. Overall the incidence of malrotation was in 20(24.7%) cases. Rotational mal-alignment is one of the preventable complications after IMnailing which can be assesed intra-operatively under fluoroscope.

  10. An Exploratory Study of Reading Comprehension in College Students After Acquired Brain Injury.

    Science.gov (United States)

    Sohlberg, McKay Moore; Griffiths, Gina G; Fickas, Stephen

    2015-08-01

    This exploratory study builds on the small body of existing research investigating reading comprehension deficits in college students with acquired brain injury (ABI). Twenty-four community college students with ABI completed a battery of questionnaires and standardized tests to characterize self-perceptions of academic reading ability, performance on a standardized reading comprehension measure, and a variety of cognitive functions of this population. Half of the participants in the sample reported traumatic brain injury (n = 12) and half reported nontraumatic ABI (n = 12). College students with both traumatic and nontraumatic ABI cite problems with reading comprehension and academic performance postinjury. Mean performance on a standardized reading measure, the Nelson-Denny Reading Test (Brown, Fischo, & Hanna, 1993), was low to below average and was significantly correlated with performance on the Speed and Capacity of Language Processing Test (Baddeley, Emslie, & Nimmo-Smith, 1992). Injury status of traumatic versus nontraumatic ABI did not differentiate results. Regression analysis showed that measures of verbal attention and suppression obtained from the California Verbal Language Test-II (Delis, Kramer, Kaplan, & Ober, 2000) predicted total scores on the Nelson-Denny Reading Test. College students with ABI are vulnerable to reading comprehension problems. Results align with other research suggesting that verbal attention and suppression problems may be contributing factors.

  11. Advantages of genome sequencing by long-read sequencer using SMRT technology in medical area.

    Science.gov (United States)

    Nakano, Kazuma; Shiroma, Akino; Shimoji, Makiko; Tamotsu, Hinako; Ashimine, Noriko; Ohki, Shun; Shinzato, Misuzu; Minami, Maiko; Nakanishi, Tetsuhiro; Teruya, Kuniko; Satou, Kazuhito; Hirano, Takashi

    2017-07-01

    PacBio RS II is the first commercialized third-generation DNA sequencer able to sequence a single molecule DNA in real-time without amplification. PacBio RS II's sequencing technology is novel and unique, enabling the direct observation of DNA synthesis by DNA polymerase. PacBio RS II confers four major advantages compared to other sequencing technologies: long read lengths, high consensus accuracy, a low degree of bias, and simultaneous capability of epigenetic characterization. These advantages surmount the obstacle of sequencing genomic regions such as high/low G+C, tandem repeat, and interspersed repeat regions. Moreover, PacBio RS II is ideal for whole genome sequencing, targeted sequencing, complex population analysis, RNA sequencing, and epigenetics characterization. With PacBio RS II, we have sequenced and analyzed the genomes of many species, from viruses to humans. Herein, we summarize and review some of our key genome sequencing projects, including full-length viral sequencing, complete bacterial genome and almost-complete plant genome assemblies, and long amplicon sequencing of a disease-associated gene region. We believe that PacBio RS II is not only an effective tool for use in the basic biological sciences but also in the medical/clinical setting.

  12. The Alignment Jacks of the LHC Cryomagnets

    CERN Document Server

    Dwivedi, J; Goswami, S G; Madhumurthy, V; Parma, V; Soni, H C

    2004-01-01

    The precise alignment of the 1232 dipoles, 474 Short Straight Sections (SSS) and some other components of the LHC collider, requires the use of 6800 jacks. The specific requirements and the need for a cost-effective solution for this large production, justified the development and industrialisation of a dedicated mechanical jack. The jack was developed, and is now being produced by Centre for Advanced Technology, India, in the framework of a collaboration between CERN and the Department of Atomic Energy in India. Three jacks support each of the 32-ton heavy, 15-meter long cryo-dipole of LHC, and provide the required alignment features. Identical jacks support the lighter LHC Short Straight Sections. Presently, the mass production of 6800 jacks is in progress with two Indian manufacturers, and 3545 jacks have already been delivered to CERN by April 2004. Considering the successful performance of the jacks, it is now envisaged to extend their use, with some modifications, for even higher-demanding alignment of ...

  13. Alignment of the ATLAS Inner Detector

    CERN Document Server

    Marti-Garcia, Salvador; The ATLAS collaboration

    2016-01-01

    The Run-2 of the LHC has presented new challenges to track and vertex reconstruction with higher energies, denser jets and higher rates. In addition, the Insertable B-layer (IBL) is a fourth pixel layer, which has been deployed at the centre of ATLAS during the longshutdown-1 of the LHC. The physics performance of the experiment requires a high resolution and unbiased measurement of all charged particle kinematic parameters. In its turn, the performance of the tracking depends, among many other issues, on the accurate determination of the alignment parameters of the tracking sensors. The offline track based alignment of the ATLAS tracking system has to deal with more than 700,000 degrees of freedom (DoF). This represents a considerable numerical challenge in terms of both CPU time and precision. During Run-2, a mechanical distortion of the IBL staves up to 20um has been observed during data-taking, plus other short time scale movements. The talk will also describe the procedures implemented to detect and remo...

  14. COCOA CMS Object-oriented Code for Optical Alignment

    CERN Document Server

    Arce, P

    2007-01-01

    COCOA is a C++ software that is able to reconstruct the positions, angular orientations, and internal optical parameters of any optical system described by a seamless combination of many different types of optical objects. The program also handles the propagation of uncertainties, which makes it very useful to simulate the system in the design phase. The software is currently in use by the different optical alignment systems of CMS and is integrated in the CMS framework so that it can read the geometry description from simple text files or the CMS XML format, and the input and output data from text files, ROOT trees, or an Oracle or MySQL database.

  15. Harnessing cross-species alignment to discover SNPs and generate a draft genome sequence of a bighorn sheep (Ovis canadensis).

    Science.gov (United States)

    Miller, Joshua M; Moore, Stephen S; Stothard, Paul; Liao, Xiaoping; Coltman, David W

    2015-05-20

    Whole genome sequences (WGS) have proliferated as sequencing technology continues to improve and costs decline. While many WGS of model or domestic organisms have been produced, a growing number of non-model species are also being sequenced. In the absence of a reference, construction of a genome sequence necessitates de novo assembly which may be beyond the ability of many labs due to the large volumes of raw sequence data and extensive bioinformatics required. In contrast, the presence of a reference WGS allows for alignment which is more tractable than assembly. Recent work has highlighted that the reference need not come from the same species, potentially enabling a wide array of species WGS to be constructed using cross-species alignment. Here we report on the creation a draft WGS from a single bighorn sheep (Ovis canadensis) using alignment to the closely related domestic sheep (Ovis aries). Two sequencing libraries on SOLiD platforms yielded over 865 million reads, and combined alignment to the domestic sheep reference resulted in a nearly complete sequence (95% coverage of the reference) at an average of 12x read depth (104 SD). From this we discovered over 15 million variants and annotated them relative to the domestic sheep reference. We then conducted an enrichment analysis of those SNPs showing fixed differences between the reference and sequenced individual and found significant differences in a number of gene ontology (GO) terms, including those associated with reproduction, muscle properties, and bone deposition. Our results demonstrate that cross-species alignment enables the creation of novel WGS for non-model organisms. The bighorn sheep WGS will provide a resource for future resequencing studies or comparative genomics.

  16. The Impact of Intensive Reading Intervention on Level of Attention in Middle School Students

    Science.gov (United States)

    Roberts, Greg; Rane, Shruti; Fall, Anna-Mária; Denton, Carolyn A.; Fletcher, Jack M.; Vaughn, Sharon

    2014-01-01

    Objective The purpose of the study was to estimate the impact of reading intervention on ratings of student attention over time. Method We used extant data from a longitudinal randomized study of a response-based reading intervention to fit a multiple-indicator, multilevel growth model. The sample at randomization was 54% male, 18% limited English proficient, 85% eligible for free or reduced-price lunch, 58% African American, and 32% Hispanic. Reading ability was measured by using the Woodcock-Johnson III Tests of Achievement. Attention was measured by using the Strengths and Weaknesses of ADHD Symptoms and Normal Behavior Scale. Results Findings indicate that intensive, response-based reading intervention over 3 years improved reading achievement and behavioral attention in middle school struggling readers, with treatment directly affecting reading, which in turn influenced attention. In the business-as-usual condition, there was no relation between improved reading and attention. Conclusions The results are consistent with a correlated liabilities model of comorbidity. The results do not align with the inattention-as-cause hypothesis, which predicts that reading intervention should not affect attention. The findings do not support, but do not necessarily preclude, the phenocopy hypothesis. The results are especially pertinent for older students who may be inattentive partly because of years of struggling with reading. PMID:24885289

  17. 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.

  18. (Con)text-specific effects of visual dysfunction on reading in posterior cortical atrophy.

    Science.gov (United States)

    Yong, Keir X X; Shakespeare, Timothy J; Cash, Dave; Henley, Susie M D; Warren, Jason D; Crutch, Sebastian J

    2014-08-01

    Reading deficits are a common early feature of the degenerative syndrome posterior cortical atrophy (PCA) but are poorly understood even at the single word level. The current study evaluated the reading accuracy and speed of 26 PCA patients, 17 typical Alzheimer's disease (tAD) patients and 14 healthy controls on a corpus of 192 single words in which the following perceptual properties were manipulated systematically: inter-letter spacing, font size, length, font type, case and confusability. PCA reading was significantly less accurate and slower than tAD patients and controls, with performance significantly adversely affected by increased letter spacing, size, length and font (cursive < non-cursive), and characterised by visual errors (69% of all error responses). By contrast, tAD and control accuracy rates were at or near ceiling, letter spacing was the only perceptual factor to influence reading speed in the same direction as controls, and, in contrast to PCA patients, control reading was faster for larger font sizes. The inverse size effect in PCA (less accurate reading of large than small font size print) was associated with lower grey matter volume in the right superior parietal lobule. Reading accuracy was associated with impairments of early visual (especially crowding), visuoperceptual and visuospatial processes. However, these deficits were not causally related to a universal impairment of reading as some patients showed preserved reading for small, unspaced words despite grave visual deficits. Rather, the impact of specific types of visual dysfunction on reading was found to be (con)text specific, being particularly evident for large, spaced, lengthy words. These findings improve the characterisation of dyslexia in PCA, shed light on the causative and associative factors, and provide clear direction for the development of reading aids and strategies to maximise and sustain reading ability in the early stages of disease. Copyright © 2014. Published by

  19. The Utility of the Dynamic Indicators of Basic Early Literacy Skills (DIBELS) in Predicting Reading Achievement

    Science.gov (United States)

    Echols, Julie M. Young

    2010-01-01

    Reading proficiency is the goal of many local and national reading initiatives. A key component of these initiatives is accurate and reliable reading assessment. In this high-stakes testing arena, the Dynamic Indicators of Basic Early Literacy Skills (DIBELS) has emerged as a preferred measure for identification of students at risk for reading…

  20. 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.

  1. G-MAPSEQ – a new method for mapping reads to a reference genome

    Directory of Open Access Journals (Sweden)

    Wojciechowski Pawel

    2016-06-01

    Full Text Available The problem of reads mapping to a reference genome is one of the most essential problems in modern computational biology. The most popular algorithms used to solve this problem are based on the Burrows-Wheeler transform and the FM-index. However, this causes some issues with highly mutated sequences due to a limited number of mutations allowed. G-MAPSEQ is a novel, hybrid algorithm combining two interesting methods: alignment-free sequence comparison and an ultra fast sequence alignment. The former is a fast heuristic algorithm which uses k-mer characteristics of nucleotide sequences to find potential mapping places. The latter is a very fast GPU implementation of sequence alignment used to verify the correctness of these mapping positions. The source code of G-MAPSEQ along with other bioinformatic software is available at: http://gpualign.cs.put.poznan.pl.

  2. 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.

  3. MATAM: reconstruction of phylogenetic marker genes from short sequencing reads in metagenomes.

    Science.gov (United States)

    Pericard, Pierre; Dufresne, Yoann; Couderc, Loïc; Blanquart, Samuel; Touzet, Hélène

    2018-02-15

    Advances in the sequencing of uncultured environmental samples, dubbed metagenomics, raise a growing need for accurate taxonomic assignment. Accurate identification of organisms present within a community is essential to understanding even the most elementary ecosystems. However, current high-throughput sequencing technologies generate short reads which partially cover full-length marker genes and this poses difficult bioinformatic challenges for taxonomy identification at high resolution. We designed MATAM, a software dedicated to the fast and accurate targeted assembly of short reads sequenced from a genomic marker of interest. The method implements a stepwise process based on construction and analysis of a read overlap graph. It is applied to the assembly of 16S rRNA markers and is validated on simulated, synthetic and genuine metagenomes. We show that MATAM outperforms other available methods in terms of low error rates and recovered fractions and is suitable to provide improved assemblies for precise taxonomic assignments. https://github.com/bonsai-team/matam. pierre.pericard@gmail.com or helene.touzet@univ-lille1.fr. Supplementary data are available at Bioinformatics online. © The Author (2017). Published by Oxford University Press. All rights reserved. For Permissions, please email: journals.permissions@oup.com

  4. Induced alignment and measurement of dipolar couplings of an SH2 domain through direct binding with filamentous phage

    International Nuclear Information System (INIS)

    Dahlke Ojennus, Deanna; Mitton-Fry, Rachel M.; Wuttke, Deborah S.

    1999-01-01

    Large residual 15 N- 1 H dipolar couplings have been measured in a Src homology II domain aligned at Pf1 bacteriophage concentrations an order of magnitude lower than used for induction of a similar degree of alignment of nucleic acids and highly acidic proteins. An increase in 1 H and 15 N protein linewidths and a decrease in T 2 and T 1 ρ relaxation time constants implicates a binding interaction between the protein and phage as the mechanism of alignment. However, the associated increased linewidth does not preclude the accurate measurement of large dipolar couplings in the aligned protein. A good correlation is observed between measured dipolar couplings and predicted values based on the high resolution NMR structure of the SH2 domain. The observation of binding-induced protein alignment promises to broaden the scope of alignment techniques by extending their applicability to proteins that are able to interact weakly with the alignment medium

  5. Estimates of statistical significance for comparison of individual positions in multiple sequence alignments

    Directory of Open Access Journals (Sweden)

    Sadreyev Ruslan I

    2004-08-01

    Full Text Available Abstract Background Profile-based analysis of multiple sequence alignments (MSA allows for accurate comparison of protein families. Here, we address the problems of detecting statistically confident dissimilarities between (1 MSA position and a set of predicted residue frequencies, and (2 between two MSA positions. These problems are important for (i evaluation and optimization of methods predicting residue occurrence at protein positions; (ii detection of potentially misaligned regions in automatically produced alignments and their further refinement; and (iii detection of sites that determine functional or structural specificity in two related families. Results For problems (1 and (2, we propose analytical estimates of P-value and apply them to the detection of significant positional dissimilarities in various experimental situations. (a We compare structure-based predictions of residue propensities at a protein position to the actual residue frequencies in the MSA of homologs. (b We evaluate our method by the ability to detect erroneous position matches produced by an automatic sequence aligner. (c We compare MSA positions that correspond to residues aligned by automatic structure aligners. (d We compare MSA positions that are aligned by high-quality manual superposition of structures. Detected dissimilarities reveal shortcomings of the automatic methods for residue frequency prediction and alignment construction. For the high-quality structural alignments, the dissimilarities suggest sites of potential functional or structural importance. Conclusion The proposed computational method is of significant potential value for the analysis of protein families.

  6. 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 ...

  7. 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...

  8. CSA: An efficient algorithm to improve circular DNA multiple alignment

    Directory of Open Access Journals (Sweden)

    Pereira Luísa

    2009-07-01

    Full Text Available Abstract Background The comparison of homologous sequences from different species is an essential approach to reconstruct the evolutionary history of species and of the genes they harbour in their genomes. Several complete mitochondrial and nuclear genomes are now available, increasing the importance of using multiple sequence alignment algorithms in comparative genomics. MtDNA has long been used in phylogenetic analysis and errors in the alignments can lead to errors in the interpretation of evolutionary information. Although a large number of multiple sequence alignment algorithms have been proposed to date, they all deal with linear DNA and cannot handle directly circular DNA. Researchers interested in aligning circular DNA sequences must first rotate them to the "right" place using an essentially manual process, before they can use multiple sequence alignment tools. Results In this paper we propose an efficient algorithm that identifies the most interesting region to cut circular genomes in order to improve phylogenetic analysis when using standard multiple sequence alignment algorithms. This algorithm identifies the largest chain of non-repeated longest subsequences common to a set of circular mitochondrial DNA sequences. All the sequences are then rotated and made linear for multiple alignment purposes. To evaluate the effectiveness of this new tool, three different sets of mitochondrial DNA sequences were considered. Other tests considering randomly rotated sequences were also performed. The software package Arlequin was used to evaluate the standard genetic measures of the alignments obtained with and without the use of the CSA algorithm with two well known multiple alignment algorithms, the CLUSTALW and the MAVID tools, and also the visualization tool SinicView. Conclusion The results show that a circularization and rotation pre-processing step significantly improves the efficiency of public available multiple sequence alignment

  9. The Relationship Between State and District Content Standards:Issues of Alignment, Influence and Utility

    Directory of Open Access Journals (Sweden)

    Elizabeth Dutro

    2004-08-01

    Full Text Available At the core of standards-based reform are content standards--statements about what students should know and be able to do. Although it is state standards that are the focus of much public attention and consume substantial resources, many local school districts have developed their own content standards in the major subject areas. However, we know very little about the role state standards have played in local standards efforts. In this article we report on a study of the relationship between state and local content standards in reading in four states and districts. Through interviews with key personnel in each state, and district and analyses of state and local content standards in reading, we explored the alignment between state and district content standards, the path of influence between the two, and the role of high-stakes tests in state and districts reform efforts. Our findings suggest that alignment had multiple meanings and that state standards had differential utility to districts, ranging from helpful to benign to nuisance. This wide variability was influenced by the nature of the standards themselves, the state vision of alignment and local control, districts’ own engagement and commitment to professional development, and student performance on high-stakes tests. We explore implications for the future of content standards as the cornerstone of standards-based reform and argue that states must promote district ownership and expand accountability if state content standards are to have any relevance for local efforts to reform teaching and learning.

  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. An accurate and rapid continuous wavelet dynamic time warping algorithm for unbalanced global mapping in nanopore sequencing

    KAUST Repository

    Han, Renmin

    2017-12-24

    Long-reads, point-of-care, and PCR-free are the promises brought by nanopore sequencing. Among various steps in nanopore data analysis, the global mapping between the raw electrical current signal sequence and the expected signal sequence from the pore model serves as the key building block to base calling, reads mapping, variant identification, and methylation detection. However, the ultra-long reads of nanopore sequencing and an order of magnitude difference in the sampling speeds of the two sequences make the classical dynamic time warping (DTW) and its variants infeasible to solve the problem. Here, we propose a novel multi-level DTW algorithm, cwDTW, based on continuous wavelet transforms with different scales of the two signal sequences. Our algorithm starts from low-resolution wavelet transforms of the two sequences, such that the transformed sequences are short and have similar sampling rates. Then the peaks and nadirs of the transformed sequences are extracted to form feature sequences with similar lengths, which can be easily mapped by the original DTW. Our algorithm then recursively projects the warping path from a lower-resolution level to a higher-resolution one by building a context-dependent boundary and enabling a constrained search for the warping path in the latter. Comprehensive experiments on two real nanopore datasets on human and on Pandoraea pnomenusa, as well as two benchmark datasets from previous studies, demonstrate the efficiency and effectiveness of the proposed algorithm. In particular, cwDTW can almost always generate warping paths that are very close to the original DTW, which are remarkably more accurate than the state-of-the-art methods including FastDTW and PrunedDTW. Meanwhile, on the real nanopore datasets, cwDTW is about 440 times faster than FastDTW and 3000 times faster than the original DTW. Our program is available at https://github.com/realbigws/cwDTW.

  12. An Alignment Model for Collaborative Value Networks

    Science.gov (United States)

    Bremer, Carlos; Azevedo, Rodrigo Cambiaghi; Klen, Alexandra Pereira

    This paper presents parts of the work carried out in several global organizations through the development of strategic projects with high tactical and operational complexity. By investing in long-term relationships, strongly operating in the transformation of the competitive model and focusing on the value chain management, the main aim of these projects was the alignment of multiple value chains. The projects were led by the Axia Transformation Methodology as well as by its Management Model and following the principles of Project Management. As a concrete result of the efforts made in the last years in the Brazilian market this work also introduces the Alignment Model which supports the transformation process that the companies undergo.

  13. Program for PET image alignment: Effects on calculated differences in cerebral metabolic rates for glucose

    International Nuclear Information System (INIS)

    Phillips, R.L.; London, E.D.; Links, J.M.; Cascella, N.G.

    1990-01-01

    A program was developed to align positron emission tomography images from multiple studies on the same subject. The program allowed alignment of two images with a fineness of one-tenth the width of a pixel. The indications and effects of misalignment were assessed in eight subjects from a placebo-controlled double-blind crossover study on the effects of cocaine on regional cerebral metabolic rates for glucose. Visual examination of a difference image provided a sensitive and accurate tool for assessing image alignment. Image alignment within 2.8 mm was essential to reduce variability of measured cerebral metabolic rates for glucose. Misalignment by this amount introduced errors on the order of 20% in the computed metabolic rate for glucose. These errors propagate to the difference between metabolic rates for a subject measured in basal versus perturbed states

  14. A simple and accurate method for bidimensional position read-out of parallel plate avalanche counters

    International Nuclear Information System (INIS)

    Breskin, A.; Zwang, N.

    1977-01-01

    A simple method for bidimensional position read-out of Parallel Plate Avalanche counters (PPAC) has been developed, using the induced charge technique. An accuracy better than 0.5 mm (FWHM) has been achieved for both coordinates with 5.5. MeV α-particles at gas pressures of 10-40 torr. (author)

  15. Prediction of Poly(A Sites by Poly(A Read Mapping.

    Directory of Open Access Journals (Sweden)

    Thomas Bonfert

    Full Text Available RNA-seq reads containing part of the poly(A tail of transcripts (denoted as poly(A reads provide the most direct evidence for the position of poly(A sites in the genome. However, due to reduced coverage of poly(A tails by reads, poly(A reads are not routinely identified during RNA-seq mapping. Nevertheless, recent studies for several herpesviruses successfully employed mapping of poly(A reads to identify herpesvirus poly(A sites using different strategies and customized programs. To more easily allow such analyses without requiring additional programs, we integrated poly(A read mapping and prediction of poly(A sites into our RNA-seq mapping program ContextMap 2. The implemented approach essentially generalizes previously used poly(A read mapping approaches and combines them with the context-based approach of ContextMap 2 to take into account information provided by other reads aligned to the same location. Poly(A read mapping using ContextMap 2 was evaluated on real-life data from the ENCODE project and compared against a competing approach based on transcriptome assembly (KLEAT. This showed high positive predictive value for our approach, evidenced also by the presence of poly(A signals, and considerably lower runtime than KLEAT. Although sensitivity is low for both methods, we show that this is in part due to a high extent of spurious results in the gold standard set derived from RNA-PET data. Sensitivity improves for poly(A sites of known transcripts or determined with a more specific poly(A sequencing protocol and increases with read coverage on transcript ends. Finally, we illustrate the usefulness of the approach in a high read coverage scenario by a re-analysis of published data for herpes simplex virus 1. Thus, with current trends towards increasing sequencing depth and read length, poly(A read mapping will prove to be increasingly useful and can now be performed automatically during RNA-seq mapping with ContextMap 2.

  16. Spreadsheet-based program for alignment of overlapping DNA sequences.

    Science.gov (United States)

    Anbazhagan, R; Gabrielson, E

    1999-06-01

    Molecular biology laboratories frequently face the challenge of aligning small overlapping DNA sequences derived from a long DNA segment. Here, we present a short program that can be used to adapt Excel spreadsheets as a tool for aligning DNA sequences, regardless of their orientation. The program runs on any Windows or Macintosh operating system computer with Excel 97 or Excel 98. The program is available for use as an Excel file, which can be downloaded from the BioTechniques Web site. Upon execution, the program opens a specially designed customized workbook and is capable of identifying overlapping regions between two sequence fragments and displaying the sequence alignment. It also performs a number of specialized functions such as recognition of restriction enzyme cutting sites and CpG island mapping without costly specialized software.

  17. 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.

  18. 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)

  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. TCS: a new multiple sequence alignment reliability measure to estimate alignment accuracy and improve phylogenetic tree reconstruction.

    Science.gov (United States)

    Chang, Jia-Ming; Di Tommaso, Paolo; Notredame, Cedric

    2014-06-01

    Multiple sequence alignment (MSA) is a key modeling procedure when analyzing biological sequences. Homology and evolutionary modeling are the most common applications of MSAs. Both are known to be sensitive to the underlying MSA accuracy. In this work, we show how this problem can be partly overcome using the transitive consistency score (TCS), an extended version of the T-Coffee scoring scheme. Using this local evaluation function, we show that one can identify the most reliable portions of an MSA, as judged from BAliBASE and PREFAB structure-based reference alignments. We also show how this measure can be used to improve phylogenetic tree reconstruction using both an established simulated data set and a novel empirical yeast data set. For this purpose, we describe a novel lossless alternative to site filtering that involves overweighting the trustworthy columns. Our approach relies on the T-Coffee framework; it uses libraries of pairwise alignments to evaluate any third party MSA. Pairwise projections can be produced using fast or slow methods, thus allowing a trade-off between speed and accuracy. We compared TCS with Heads-or-Tails, GUIDANCE, Gblocks, and trimAl and found it to lead to significantly better estimates of structural accuracy and more accurate phylogenetic trees. The software is available from www.tcoffee.org/Projects/tcs. © The Author 2014. Published by Oxford University Press on behalf of the Society for Molecular Biology and Evolution. All rights reserved. For permissions, please e-mail: journals.permissions@oup.com.

  2. Using pseudoalignment and base quality to accurately quantify microbial community composition.

    Directory of Open Access Journals (Sweden)

    Mark Reppell

    2018-04-01

    Full Text Available Pooled DNA from multiple unknown organisms arises in a variety of contexts, for example microbial samples from ecological or human health research. Determining the composition of pooled samples can be difficult, especially at the scale of modern sequencing data and reference databases. Here we propose a novel method for taxonomic profiling in pooled DNA that combines the speed and low-memory requirements of k-mer based pseudoalignment with a likelihood framework that uses base quality information to better resolve multiply mapped reads. We apply the method to the problem of classifying 16S rRNA reads using a reference database of known organisms, a common challenge in microbiome research. Using simulations, we show the method is accurate across a variety of read lengths, with different length reference sequences, at different sample depths, and when samples contain reads originating from organisms absent from the reference. We also assess performance in real 16S data, where we reanalyze previous genetic association data to show our method discovers a larger number of quantitative trait associations than other widely used methods. We implement our method in the software Karp, for k-mer based analysis of read pools, to provide a novel combination of speed and accuracy that is uniquely suited for enhancing discoveries in microbial studies.

  3. Reading in Place

    Science.gov (United States)

    Price, Leah

    2012-01-01

    The digital age is rendering books more common, not less. It is true that there is nothing new about "furniture books": The trade in reading material has long been dwarfed by the market for coffee-table books, books that steakhouse chains buy by the yard, empty bindings that interior decorators use to accessorize the upholstery. As coffee-table…

  4. What Brain Research Suggests for Teaching Reading Strategies

    Science.gov (United States)

    Willis, Judy

    2009-01-01

    How the brain learns to read has been the subject of much neuroscience educational research. Evidence is mounting for identifiable networks of connected neurons that are particularly active during reading processes such as response to visual and auditory stimuli, relating new information to prior knowledge, long-term memory storage, comprehension,…

  5. Separating metagenomic short reads into genomes via clustering

    Directory of Open Access Journals (Sweden)

    Tanaseichuk Olga

    2012-09-01

    Full Text Available Abstract Background The metagenomics approach allows the simultaneous sequencing of all genomes in an environmental sample. This results in high complexity datasets, where in addition to repeats and sequencing errors, the number of genomes and their abundance ratios are unknown. Recently developed next-generation sequencing (NGS technologies significantly improve the sequencing efficiency and cost. On the other hand, they result in shorter reads, which makes the separation of reads from different species harder. Among the existing computational tools for metagenomic analysis, there are similarity-based methods that use reference databases to align reads and composition-based methods that use composition patterns (i.e., frequencies of short words or l-mers to cluster reads. Similarity-based methods are unable to classify reads from unknown species without close references (which constitute the majority of reads. Since composition patterns are preserved only in significantly large fragments, composition-based tools cannot be used for very short reads, which becomes a significant limitation with the development of NGS. A recently proposed algorithm, AbundanceBin, introduced another method that bins reads based on predicted abundances of the genomes sequenced. However, it does not separate reads from genomes of similar abundance levels. Results In this work, we present a two-phase heuristic algorithm for separating short paired-end reads from different genomes in a metagenomic dataset. We use the observation that most of the l-mers belong to unique genomes when l is sufficiently large. The first phase of the algorithm results in clusters of l-mers each of which belongs to one genome. During the second phase, clusters are merged based on l-mer repeat information. These final clusters are used to assign reads. The algorithm could handle very short reads and sequencing errors. It is initially designed for genomes with similar abundance levels and then

  6. 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.

  7. Simultaneous alignment and Lorentz angle calibration in the CMS silicon tracker using Millepede II

    CERN Document Server

    Bartosik, Nazar

    2013-01-01

    The CMS silicon tracker consists of 25 684 sensors that provide measurements of trajectories of charged particles that are used by almost every physics analysis at CMS. In order to achieve high measurement precision, the positions and orientations of all sensors have to be determined very accurately. This is achieved by track-based alignment using the global fit approach of the Millepede II program. This approach is capable of determining about 200 000 parameters simultaneously.The alignment precision reached such a high level that even small calibration inaccuracies are noticeable. Therefore the alignment framework has been extended to treat position sensitive calibration parameters. Of special interest is the Lorentz angle which affects the hit positions due to the drift of the signal electrons in the magnetic field. We present the results from measurements of the Lorentz angle and its time dependence during full 2012 data taking period as well as general description of the alignment and calibration procedu...

  8. 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.

  9. Is diagnostic accuracy for detecting pulmonary nodules in chest CT reduced after a long day of reading?

    Science.gov (United States)

    Krupinski, Elizabeth A.; Berbaum, Kevin S.; Caldwell, Robert; Schartz, Kevin M.

    2012-02-01

    Radiologists are reading more cases with more images, especially in CT and MRI and thus working longer hours than ever before. There have been concerns raised regarding fatigue and whether it impacts diagnostic accuracy. This study measured the impact of reader visual fatigue by assessing symptoms, visual strain via dark focus of accommodation, and diagnostic accuracy. Twenty radiologists and 20 radiology residents were given two diagnostic performance tests searching CT chest sequences for a solitary pulmonary nodule before (rested) and after (tired) a day of clinical reading. 10 cases used free search and navigation, and the other 100 cases used preset scrolling speed and duration. Subjects filled out the Swedish Occupational Fatigue Inventory (SOFI) and the oculomotor strain subscale of the Simulator Sickness Questionnaire (SSQ) before each session. Accuracy was measured using ROC techniques. Using Swensson's technique yields an ROC area = 0.86 rested vs. 0.83 tired, p (one-tailed) = 0.09. Using Swensson's LROC technique yields an area = 0.73 rested vs. 0.66 tired, p (one-tailed) = 0.09. Using Swensson's Loc Accuracy technique yields an area = 0.77 rested vs. 0.72 tired, p (one-tailed) = 0.13). Subjective measures of fatigue increased significantly from early to late reading. To date, the results support our findings with static images and detection of bone fractures. Radiologists at the end of a long work day experience greater levels of measurable visual fatigue or strain, contributing to a decrease in diagnostic accuracy. The decrease in accuracy was not as great however as with static images.

  10. Robust species taxonomy assignment algorithm for 16S rRNA NGS reads: application to oral carcinoma samples

    Directory of Open Access Journals (Sweden)

    Nezar Noor Al-Hebshi

    2015-09-01

    Full Text Available Background: Usefulness of next-generation sequencing (NGS in assessing bacteria associated with oral squamous cell carcinoma (OSCC has been undermined by inability to classify reads to the species level. Objective: The purpose of this study was to develop a robust algorithm for species-level classification of NGS reads from oral samples and to pilot test it for profiling bacteria within OSCC tissues. Methods: Bacterial 16S V1-V3 libraries were prepared from three OSCC DNA samples and sequenced using 454's FLX chemistry. High-quality, well-aligned, and non-chimeric reads ≥350 bp were classified using a novel, multi-stage algorithm that involves matching reads to reference sequences in revised versions of the Human Oral Microbiome Database (HOMD, HOMD extended (HOMDEXT, and Greengene Gold (GGG at alignment coverage and percentage identity ≥98%, followed by assignment to species level based on top hit reference sequences. Priority was given to hits in HOMD, then HOMDEXT and finally GGG. Unmatched reads were subject to operational taxonomic unit analysis. Results: Nearly, 92.8% of the reads were matched to updated-HOMD 13.2, 1.83% to trusted-HOMDEXT, and 1.36% to modified-GGG. Of all matched reads, 99.6% were classified to species level. A total of 228 species-level taxa were identified, representing 11 phyla; the most abundant were Proteobacteria, Bacteroidetes, Firmicutes, Fusobacteria, and Actinobacteria. Thirty-five species-level taxa were detected in all samples. On average, Prevotella oris, Neisseria flava, Neisseria flavescens/subflava, Fusobacterium nucleatum ss polymorphum, Aggregatibacter segnis, Streptococcus mitis, and Fusobacterium periodontium were the most abundant. Bacteroides fragilis, a species rarely isolated from the oral cavity, was detected in two samples. Conclusion: This multi-stage algorithm maximizes the fraction of reads classified to the species level while ensuring reliable classification by giving priority to the

  11. Automatic alignment device for focal spot measurements in the center of the field for mammography

    International Nuclear Information System (INIS)

    Vieira, Marcelo A.C.; Watanabe, Alex O.; Oliveira Junior, Paulo D.; Schiabel, Homero

    2010-01-01

    Some quality control procedures used for mammography, such as focal spot evaluation, requires previous alignment of the measurement equipment with the X-ray central beam. However, alignment procedures are, in general, the most difficult task and the one that needs more time to be performed. Moreover, the operator sometimes is exposed to radiation during this procedure. This work presents an automatic alignment system for mammographic equipment that allows locating the central ray of the radiation beam and, immediately, aligns with it by dislocating itself automatically along the field. The system consists on a bidirectional moving device, connected to a CCD sensor for digital radiographic image acquisition. A computational analysis of a radiographic image, acquired at any position on the field, is performed in order to determine its positioning under the X-ray beam. Finally, a mechanical system for two moving directions, electronically controlled by a microcontroller under USB communication, makes the system to align automatically with the radiation beam central ray. The alignment process is fully automatic, fast and accurate, with no operator exposure to radiation, which allows a considerable time saving for quality control procedures achievement for mammography. (author)

  12. The Relative Impact of Aligning Tier 2 Intervention Materials with Classroom Core Reading Materials in Grades K-2

    Science.gov (United States)

    Foorman, Barbara R.; Herrera, Sarah; Dombek, Jennifer

    2018-01-01

    This randomized controlled trial in 55 low-performing schools across Florida compared 2 early literacy interventions--1 using stand-alone materials and 1 using materials embedded in the existing core reading/language arts program. A total of 3,447 students who were below the 30th percentile in vocabulary and reading-related skills participated in…

  13. Mining Student Behavior Patterns in Reading Comprehension Tasks

    Science.gov (United States)

    Peckham, Terry; McCalla, Gord

    2012-01-01

    Reading comprehension is critical in life-long learning as well as in the workplace. In this paper, we describe how multidimensional k-means clustering combined with Bloom's Taxonomy can be used to determine positive and negative cognitive skill sets with respect to reading comprehension tasks. This information could be used to inform environments…

  14. First-grade cognitive abilities as long-term predictors of reading comprehension and disability status.

    Science.gov (United States)

    Fuchs, Douglas; Compton, Donald L; Fuchs, Lynn S; Bryant, V Joan; Hamlett, Carol L; Lambert, Warren

    2012-01-01

    In a sample of 195 first graders selected for poor reading performance, the authors explored four cognitive predictors of later reading comprehension and reading disability (RD) status. In fall of first grade, the authors measured the children's phonological processing, rapid automatized naming (RAN), oral language comprehension, and nonverbal reasoning. Throughout first grade, they also modeled the students' reading progress by means of weekly Word Identification Fluency (WIF) tests to derive December and May intercepts. The authors assessed their reading comprehension in the spring of Grades 1-5. With the four cognitive variables and the WIF December intercept as predictors, 50.3% of the variance in fifth-grade reading comprehension was explained: 52.1% of this 50.3% was unique to the cognitive variables, 13.1% to the WIF December intercept, and 34.8% was shared. All five predictors were statistically significant. The same four cognitive variables with the May (rather than December) WIF intercept produced a model that explained 62.1% of the variance. Of this amount, the cognitive variables and May WIF intercept accounted for 34.5% and 27.7%, respectively; they shared 37.8%. All predictors in this model were statistically significant except RAN. Logistic regression analyses indicated that the accuracy with which the cognitive variables predicted end-of-fifth-grade RD status was 73.9%. The May WIF intercept contributed reliably to this prediction; the December WIF intercept did not. Results are discussed in terms of a role for cognitive abilities in identifying, classifying, and instructing students with severe reading problems.

  15. Alternative Text Types to Improve Reading Fluency for Competent to Struggling Readers

    Directory of Open Access Journals (Sweden)

    Timothy V. Rasinski

    2016-01-01

    Full Text Available This article offers instructional suggestions and strategies based on research and theoretical literature for developing reading fluency through the use of rhyming poetry and other texts beyond the narrative and informational texts that have been traditionally used for reading instruction. Readers’ lack of fluency in reading can be a monumental impediment to proficiency in good comprehension and overall reading competency. For all readers it is well established that as they progress in reading competence their reading ability grows (Stanovich, 1993/1994. This continued reading success begets continued reading growth; however, many struggling readers have difficulty in moving to a level of automaticity and fluency in their reading that enables them to engage in a successful practice. Lack of practice inhibits their reading comprehension. Readers’ abilities to effectively comprehend texts are significantly affected by their proficiency in accurate and automatic word recognition and prosody (May, 1998; Stanovich, 1993/1994; LaBerge & Samuels, 1974; Schreiber, 1991. Repeated reading practice has been shown to be a powerful way to improve these important fluency competencies. Certain texts are particularly well suited for repeated reading that improves both aspects of fluency

  16. SRBreak: A read-depth and split-read framework to identify breakpoints of different events inside simple copy-number variable regions

    Directory of Open Access Journals (Sweden)

    HOANG T NGUYEN

    2016-09-01

    Full Text Available Copy-number variation (CNV has been associated with increased risk of complex diseases. High throughput sequencing (HTS technologies facilitate the detection of copy-number variable regions (CNVRs and their breakpoints. This helps in understanding genome structures of genomes as well as their evolution process. Various approaches have been proposed for detecting CNV breakpoints, but currently it is still challenging for tools based on a single analysis method to identify breakpoints of CNVs. It has been shown, however, that pipelines which integrate multiple approaches are able to report more reliable breakpoints. Here, based on HTS data, we have developed a pipeline to identify approximate breakpoints (±10 bp relating to different ancestral events within a specific CNVR. The pipeline combines read-depth and split-read information to infer breakpoints, using information from multiple samples to allow an imputation approach to be taken. The main steps involve using a normal mixture model to cluster samples into different groups, followed by simple kernel-based approaches to maximise information obtained from read-depth and split-read approaches, after which common breakpoints of groups are inferred. The pipeline uses split-read information directly from CIGAR strings of BAM files, without using a re-alignment step. On simulated data sets, it was able to report breakpoints for very low-coverage samples including those for which only single-end reads were available. When applied to three loci from existing human resequencing data sets (NEGR1, LCE3, IRGM the pipeline obtained good concordance with results from the 1000 Genomes Project (92%, 100% and 82%, respectively.The package is available at https://github.com/hoangtn/SRBreak, and also as a docker-based application at https://registry.hub.docker.com/u/hoangtn/srbreak/.

  17. Alignment of the ATLAS Inner Detector Tracking System

    CERN Document Server

    Heller, C; The ATLAS collaboration

    2011-01-01

    ATLAS is one of the multipurpose experiments that records the products of the LHC proton-proton and heavy ion collisions. In order to reconstruct trajectories of charged particles produced in these collisions, ATLAS is equipped with a tracking system built using two different technologies, silicon planar sensors (pixel and microstrips) and drift-tube based detectors. Together they constitute the ATLAS Inner Detector, which is embedded in a 2 T axial field. Efficiently reconstructing tracks from charged particles traversing the detector, and precisely measure their momenta is of crucial importance for physics analyses. In order to achieve its scientific goals, an alignment of the ATLAS Inner Detector is required to accurately determine its more than 700,000 degrees of freedom. The goal of the alignment is set such that the limited knowledge of the sensor locations should not deteriorate the resolution of track parameters by more than 20% with respect to the intrinsic tracker resolution. The implementation of t...

  18. Apparatus for accurately measuring high temperatures

    Science.gov (United States)

    Smith, D.D.

    The present invention is a thermometer used for measuring furnace temperatures in the range of about 1800/sup 0/ to 2700/sup 0/C. The thermometer comprises a broadband multicolor thermal radiation sensor positioned to be in optical alignment with the end of a blackbody sight tube extending into the furnace. A valve-shutter arrangement is positioned between the radiation sensor and the sight tube and a chamber for containing a charge of high pressure gas is positioned between the valve-shutter arrangement and the radiation sensor. A momentary opening of the valve shutter arrangement allows a pulse of the high gas to purge the sight tube of air-borne thermal radiation contaminants which permits the radiation sensor to accurately measure the thermal radiation emanating from the end of the sight tube.

  19. Comparison of robust H∞ filter and Kalman filter for initial alignment of inertial navigation system

    Institute of Scientific and Technical Information of China (English)

    HAO Yan-ling; CHEN Ming-hui; LI Liang-jun; XU Bo

    2008-01-01

    There are many filtering methods that can be used for the initial alignment of an integrated inertial navigation system.This paper discussed the use of GPS,but focused on two kinds of filters for the initial alignment of an integrated strapdown inertial navigation system (SINS).One method is based on the Kalman filter (KF),and the other is based on the robust filter.Simulation results showed that the filter provides a quick transient response and a little more accurate estimate than KF,given substantial process noise or unknown noise statistics.So the robust filter is an effective and useful method for initial alignment of SINS.This research should make the use of SINS more popular,and is also a step for further research.

  20. Magnet-assisted device-level alignment for the fabrication of membrane-sandwiched polydimethylsiloxane microfluidic devices

    International Nuclear Information System (INIS)

    Lu, J-C; Liao, W-H; Tung, Y-C

    2012-01-01

    Polydimethylsiloxane (PDMS) microfluidic device is one of the most essential techniques that advance microfluidics research in recent decades. PDMS is broadly exploited to construct microfluidic devices due to its unique and advantageous material properties. To realize more functionalities, PDMS microfluidic devices with multi-layer architectures, especially those with sandwiched membranes, have been developed for various applications. However, existing alignment methods for device fabrication are mainly based on manual observations, which are time consuming, inaccurate and inconsistent. This paper develops a magnet-assisted alignment method to enhance device-level alignment accuracy and precision without complicated fabrication processes. In the developed alignment method, magnets are embedded into PDMS layers at the corners of the device. The paired magnets are arranged in symmetric positions at each PDMS layer, and the magnetic attraction force automatically pulls the PDMS layers into the aligned position during assembly. This paper also applies the method to construct a practical microfluidic device, a tunable chaotic micromixer. The results demonstrate the successful operation of the device without failure, which suggests the accurate alignment and reliable bonding achieved by the method. Consequently, the fabrication method developed in this paper is promising to be exploited to construct various membrane-sandwiched PDMS microfluidic devices with more integrated functionalities to advance microfluidics research. (paper)

  1. Quantification of Cardiomyocyte Alignment from Three-Dimensional (3D) Confocal Microscopy of Engineered Tissue.

    Science.gov (United States)

    Kowalski, William J; Yuan, Fangping; Nakane, Takeichiro; Masumoto, Hidetoshi; Dwenger, Marc; Ye, Fei; Tinney, Joseph P; Keller, Bradley B

    2017-08-01

    Biological tissues have complex, three-dimensional (3D) organizations of cells and matrix factors that provide the architecture necessary to meet morphogenic and functional demands. Disordered cell alignment is associated with congenital heart disease, cardiomyopathy, and neurodegenerative diseases and repairing or replacing these tissues using engineered constructs may improve regenerative capacity. However, optimizing cell alignment within engineered tissues requires quantitative 3D data on cell orientations and both efficient and validated processing algorithms. We developed an automated method to measure local 3D orientations based on structure tensor analysis and incorporated an adaptive subregion size to account for multiple scales. Our method calculates the statistical concentration parameter, κ, to quantify alignment, as well as the traditional orientational order parameter. We validated our method using synthetic images and accurately measured principal axis and concentration. We then applied our method to confocal stacks of cleared, whole-mount engineered cardiac tissues generated from human-induced pluripotent stem cells or embryonic chick cardiac cells and quantified cardiomyocyte alignment. We found significant differences in alignment based on cellular composition and tissue geometry. These results from our synthetic images and confocal data demonstrate the efficiency and accuracy of our method to measure alignment in 3D tissues.

  2. Voxel-based registration of simulated and real patient CBCT data for accurate dental implant pose estimation

    Science.gov (United States)

    Moreira, António H. J.; Queirós, Sandro; Morais, Pedro; Rodrigues, Nuno F.; Correia, André Ricardo; Fernandes, Valter; Pinho, A. C. M.; Fonseca, Jaime C.; Vilaça, João. L.

    2015-03-01

    The success of dental implant-supported prosthesis is directly linked to the accuracy obtained during implant's pose estimation (position and orientation). Although traditional impression techniques and recent digital acquisition methods are acceptably accurate, a simultaneously fast, accurate and operator-independent methodology is still lacking. Hereto, an image-based framework is proposed to estimate the patient-specific implant's pose using cone-beam computed tomography (CBCT) and prior knowledge of implanted model. The pose estimation is accomplished in a threestep approach: (1) a region-of-interest is extracted from the CBCT data using 2 operator-defined points at the implant's main axis; (2) a simulated CBCT volume of the known implanted model is generated through Feldkamp-Davis-Kress reconstruction and coarsely aligned to the defined axis; and (3) a voxel-based rigid registration is performed to optimally align both patient and simulated CBCT data, extracting the implant's pose from the optimal transformation. Three experiments were performed to evaluate the framework: (1) an in silico study using 48 implants distributed through 12 tridimensional synthetic mandibular models; (2) an in vitro study using an artificial mandible with 2 dental implants acquired with an i-CAT system; and (3) two clinical case studies. The results shown positional errors of 67+/-34μm and 108μm, and angular misfits of 0.15+/-0.08° and 1.4°, for experiment 1 and 2, respectively. Moreover, in experiment 3, visual assessment of clinical data results shown a coherent alignment of the reference implant. Overall, a novel image-based framework for implants' pose estimation from CBCT data was proposed, showing accurate results in agreement with dental prosthesis modelling requirements.

  3. DendroBLAST: approximate phylogenetic trees in the absence of multiple sequence alignments.

    Science.gov (United States)

    Kelly, Steven; Maini, Philip K

    2013-01-01

    The rapidly growing availability of genome information has created considerable demand for both fast and accurate phylogenetic inference algorithms. We present a novel method called DendroBLAST for reconstructing phylogenetic dendrograms/trees from protein sequences using BLAST. This method differs from other methods by incorporating a simple model of sequence evolution to test the effect of introducing sequence changes on the reliability of the bipartitions in the inferred tree. Using realistic simulated sequence data we demonstrate that this method produces phylogenetic trees that are more accurate than other commonly-used distance based methods though not as accurate as maximum likelihood methods from good quality multiple sequence alignments. In addition to tests on simulated data, we use DendroBLAST to generate input trees for a supertree reconstruction of the phylogeny of the Archaea. This independent analysis produces an approximate phylogeny of the Archaea that has both high precision and recall when compared to previously published analysis of the same dataset using conventional methods. Taken together these results demonstrate that approximate phylogenetic trees can be produced in the absence of multiple sequence alignments, and we propose that these trees will provide a platform for improving and informing downstream bioinformatic analysis. A web implementation of the DendroBLAST method is freely available for use at http://www.dendroblast.com/.

  4. DendroBLAST: approximate phylogenetic trees in the absence of multiple sequence alignments.

    Directory of Open Access Journals (Sweden)

    Steven Kelly

    Full Text Available The rapidly growing availability of genome information has created considerable demand for both fast and accurate phylogenetic inference algorithms. We present a novel method called DendroBLAST for reconstructing phylogenetic dendrograms/trees from protein sequences using BLAST. This method differs from other methods by incorporating a simple model of sequence evolution to test the effect of introducing sequence changes on the reliability of the bipartitions in the inferred tree. Using realistic simulated sequence data we demonstrate that this method produces phylogenetic trees that are more accurate than other commonly-used distance based methods though not as accurate as maximum likelihood methods from good quality multiple sequence alignments. In addition to tests on simulated data, we use DendroBLAST to generate input trees for a supertree reconstruction of the phylogeny of the Archaea. This independent analysis produces an approximate phylogeny of the Archaea that has both high precision and recall when compared to previously published analysis of the same dataset using conventional methods. Taken together these results demonstrate that approximate phylogenetic trees can be produced in the absence of multiple sequence alignments, and we propose that these trees will provide a platform for improving and informing downstream bioinformatic analysis. A web implementation of the DendroBLAST method is freely available for use at http://www.dendroblast.com/.

  5. Image-based quantification of fiber alignment within electrospun tissue engineering scaffolds is related to mechanical anisotropy.

    Science.gov (United States)

    Fee, Timothy; Downs, Crawford; Eberhardt, Alan; Zhou, Yong; Berry, Joel

    2016-07-01

    It is well documented that electrospun tissue engineering scaffolds can be fabricated with variable degrees of fiber alignment to produce scaffolds with anisotropic mechanical properties. Several attempts have been made to quantify the degree of fiber alignment within an electrospun scaffold using image-based methods. However, these methods are limited by the inability to produce a quantitative measure of alignment that can be used to make comparisons across publications. Therefore, we have developed a new approach to quantifying the alignment present within a scaffold from scanning electron microscopic (SEM) images. The alignment is determined by using the Sobel approximation of the image gradient to determine the distribution of gradient angles with an image. This data was fit to a Von Mises distribution to find the dispersion parameter κ, which was used as a quantitative measure of fiber alignment. We fabricated four groups of electrospun polycaprolactone (PCL) + Gelatin scaffolds with alignments ranging from κ = 1.9 (aligned) to κ = 0.25 (random) and tested our alignment quantification method on these scaffolds. It was found that our alignment quantification method could distinguish between scaffolds of different alignments more accurately than two other published methods. Additionally, the alignment parameter κ was found to be a good predictor the mechanical anisotropy of our electrospun scaffolds. The ability to quantify fiber alignment within and make direct comparisons of scaffold fiber alignment across publications can reduce ambiguity between published results where cells are cultured on "highly aligned" fibrous scaffolds. This could have important implications for characterizing mechanics and cellular behavior on aligned tissue engineering scaffolds. © 2016 Wiley Periodicals, Inc. J Biomed Mater Res Part A: 104A: 1680-1686, 2016. © 2016 Wiley Periodicals, Inc.

  6. 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...

  7. Electroactive Tissue Scaffolds with Aligned Pores as Instructive Platforms for Biomimetic Tissue Engineering.

    Science.gov (United States)

    Hardy, John G; Cornelison, R Chase; Sukhavasi, Rushi C; Saballos, Richard J; Vu, Philip; Kaplan, David L; Schmidt, Christine E

    2015-01-14

    Tissues in the body are hierarchically structured composite materials with tissue-specific chemical and topographical properties. Here we report the preparation of tissue scaffolds with macroscopic pores generated via the dissolution of a sacrificial supramolecular polymer-based crystal template (urea) from a biodegradable polymer-based scaffold (polycaprolactone, PCL). Furthermore, we report a method of aligning the supramolecular polymer-based crystals within the PCL, and that the dissolution of the sacrificial urea yields scaffolds with macroscopic pores that are aligned over long, clinically-relevant distances ( i.e ., centimeter scale). The pores act as topographical cues to which rat Schwann cells respond by aligning with the long axis of the pores. Generation of an interpenetrating network of polypyrrole (PPy) and poly(styrene sulfonate) (PSS) in the scaffolds yields electroactive tissue scaffolds that allow the electrical stimulation of Schwann cells cultured on the scaffolds which increases the production of nerve growth factor (NGF).

  8. A Biologically Realistic Cortical Model of Eye Movement Control in Reading

    Science.gov (United States)

    Heinzle, Jakob; Hepp, Klaus; Martin, Kevan A. C.

    2010-01-01

    Reading is a highly complex task involving a precise integration of vision, attention, saccadic eye movements, and high-level language processing. Although there is a long history of psychological research in reading, it is only recently that imaging studies have identified some neural correlates of reading. Thus, the underlying neural mechanisms…

  9. Precise Alignment and Permanent Mounting of Thin and Lightweight X-ray Segments

    Science.gov (United States)

    Biskach, Michael P.; Chan, Kai-Wing; Hong, Melinda N.; Mazzarella, James R.; McClelland, Ryan S.; Norman, Michael J.; Saha, Timo T.; Zhang, William W.

    2012-01-01

    To provide observations to support current research efforts in high energy astrophysics. future X-ray telescope designs must provide matching or better angular resolution while significantly increasing the total collecting area. In such a design the permanent mounting of thin and lightweight segments is critical to the overall performance of the complete X-ray optic assembly. The thin and lightweight segments used in the assemhly of the modules are desigued to maintain and/or exceed the resolution of existing X-ray telescopes while providing a substantial increase in collecting area. Such thin and delicate X-ray segments are easily distorted and yet must be aligned to the arcsecond level and retain accurate alignment for many years. The Next Generation X-ray Optic (NGXO) group at NASA Goddard Space Flight Center has designed, assembled. and implemented new hardware and procedures mth the short term goal of aligning three pairs of X-ray segments in a technology demonstration module while maintaining 10 arcsec alignment through environmental testing as part of the eventual design and construction of a full sized module capable of housing hundreds of X-ray segments. The recent attempts at multiple segment pair alignment and permanent mounting is described along with an overview of the procedure used. A look into what the next year mll bring for the alignment and permanent segment mounting effort illustrates some of the challenges left to overcome before an attempt to populate a full sized module can begin.

  10. 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.

  11. Indoor localization using unsupervised manifold alignment with geometry perturbation

    KAUST Repository

    Majeed, Khaqan

    2014-04-01

    The main limitation of deploying/updating Received Signal Strength (RSS) based indoor localization is the construction of fingerprinted radio map, which is quite a hectic and time-consuming process especially when the indoor area is enormous and/or dynamic. Different approaches have been undertaken to reduce such deployment/update efforts, but the performance degrades when the fingerprinting load is reduced below a certain level. In this paper, we propose an indoor localization scheme that requires as low as 1% fingerprinting load. This scheme employs unsupervised manifold alignment that takes crowd sourced RSS readings and localization requests as source data set and the environment\\'s plan coordinates as destination data set. The 1% fingerprinting load is only used to perturb the local geometries in the destination data set. Our proposed algorithm was shown to achieve less than 5 m mean localization error with 1% fingerprinting load and a limited number of crowd sourced readings, when other learning based localization schemes pass the 10 m mean error with the same information.

  12. Indoor localization using unsupervised manifold alignment with geometry perturbation

    KAUST Repository

    Majeed, Khaqan; Sorour, Sameh; Al-Naffouri, Tareq Y.; Valaee, Shahrokh

    2014-01-01

    The main limitation of deploying/updating Received Signal Strength (RSS) based indoor localization is the construction of fingerprinted radio map, which is quite a hectic and time-consuming process especially when the indoor area is enormous and/or dynamic. Different approaches have been undertaken to reduce such deployment/update efforts, but the performance degrades when the fingerprinting load is reduced below a certain level. In this paper, we propose an indoor localization scheme that requires as low as 1% fingerprinting load. This scheme employs unsupervised manifold alignment that takes crowd sourced RSS readings and localization requests as source data set and the environment's plan coordinates as destination data set. The 1% fingerprinting load is only used to perturb the local geometries in the destination data set. Our proposed algorithm was shown to achieve less than 5 m mean localization error with 1% fingerprinting load and a limited number of crowd sourced readings, when other learning based localization schemes pass the 10 m mean error with the same information.

  13. Evaluation of GMI and PMI diffeomorphic‐based demons algorithms for aligning PET and CT Images

    Science.gov (United States)

    Yang, Juan; Zhang, You; Yin, Yong

    2015-01-01

    Fusion of anatomic information in computed tomography (CT) and functional information in F18‐FDG positron emission tomography (PET) is crucial for accurate differentiation of tumor from benign masses, designing radiotherapy treatment plan and staging of cancer. Although current PET and CT images can be acquired from combined F18‐FDG PET/CT scanner, the two acquisitions are scanned separately and take a long time, which may induce potential positional errors in global and local caused by respiratory motion or organ peristalsis. So registration (alignment) of whole‐body PET and CT images is a prerequisite for their meaningful fusion. The purpose of this study was to assess the performance of two multimodal registration algorithms for aligning PET and CT images. The proposed gradient of mutual information (GMI)‐based demons algorithm, which incorporated the GMI between two images as an external force to facilitate the alignment, was compared with the point‐wise mutual information (PMI) diffeomorphic‐based demons algorithm whose external force was modified by replacing the image intensity difference in diffeomorphic demons algorithm with the PMI to make it appropriate for multimodal image registration. Eight patients with esophageal cancer(s) were enrolled in this IRB‐approved study. Whole‐body PET and CT images were acquired from a combined F18‐FDG PET/CT scanner for each patient. The modified Hausdorff distance (dMH) was used to evaluate the registration accuracy of the two algorithms. Of all patients, the mean values and standard deviations (SDs) of dMH were 6.65 (± 1.90) voxels and 6.01 (± 1.90) after the GMI‐based demons and the PMI diffeomorphic‐based demons registration algorithms respectively. Preliminary results on oncological patients showed that the respiratory motion and organ peristalsis in PET/CT esophageal images could not be neglected, although a combined F18‐FDG PET/CT scanner was used for image acquisition. The PMI

  14. Automatic joint alignment measurements from pre- and post-operative long leg standing radiographs

    NARCIS (Netherlands)

    Goossen, A.; Weber, G.M.; Dries, S.P.M.

    2012-01-01

    Objectives: For diagnosis or treatment assessment of knee joint osteoarthritis it is required to measure bone morphometry from radiographic images. We propose a method for automatic measurement of joint alignment from pre-operative as well as post-operative radiographs.Methods: In a two step

  15. Iconic Memory and Reading Performance in Nine-Year-Old Children

    Science.gov (United States)

    Riding, R. J.; Pugh, J. C.

    1977-01-01

    The reading process incorporates three factors: images registered in visual sensory memory, semantic analysis in short-term memory, and long-term memory storage. The focus here is on the contribution of sensory memory to reading performance. (Author/RK)

  16. Development of the Portuguese version of a standardized reading test: the Radner-Coimbra Charts

    Directory of Open Access Journals (Sweden)

    Andreia Martins Rosa

    Full Text Available ABSTRACT Purpose: To develop 27 short sentence optotypes for the Portuguese version of the Radner Reading Charts. Methods: Thirty-four Portuguese sentences were constructed following the concept of the Radner Reading Charts to obtain highly comparable sentences in terms of lexical difficulty, syntactical complexity, word length, number of syllables, and position of words. A long text (106 words at the 5th grade reading level was also tested to assess the validity of the reading speeds obtained with the short sentences. The short sentences and long text were tested in 50 volunteers with similar educational backgrounds (mean age 30.98 years ± 6.99 years, range 19-47 years. Reading speeds were measured with a stop-watch and reported as words per minute (wpm. The reading time for each of the short sentences to be selected for the chart was defined as falling within the range of the mean ± 0.40 × standard deviation (SD. Results: The overall mean reading speed for each of the short sentences was 235.43 ± 36.39 wpm. The 27 sentences with a mean between 220.8 and 250.0 wpm (overall mean ± 0.40 × SD were selected for construction of the reading charts. The mean reading speed for the long text was 212.42 ± 26.20 wpm. Correlation between the selected short sentences and long text was high (r =0.86. Reliability analysis yielded an overall Cronbach's alpha coefficient of 0.97. Conclusions: The 27 short Portuguese sentences were highly comparable in terms of syntactical structure, number, position and length of words, lexical difficulty, and reading length. This reading test can overcome the limitations of the current tests for homogeneity and comparability, reducing subjectivity in the evaluation of the functional outcomes of medical and surgical ophthalmologic treatments.

  17. From fluency to comprehension powerful instruction through authentic reading

    CERN Document Server

    Rasinski, Timothy

    2013-01-01

    Helping teachers move beyond fluency as measured by speed alone, this book focuses on building the skills that students need to read accurately, meaningfully, and expressively--the essential components of reading comprehension. Each concise chapter presents a tried-and-true instructional or assessment strategy and shows how K-12 teachers can apply it in their own classrooms, using a wide variety of engaging texts. Special features include classroom examples, ""Your Turn"" activities, and 24 reproducible forms, in a large-size format for easy photocopying. Purchasers also get access to a

  18. Sagittal alignment after single cervical disc arthroplasty.

    Science.gov (United States)

    Guérin, Patrick; Obeid, Ibrahim; Gille, Olivier; Bourghli, Anouar; Luc, Stéphane; Pointillart, Vincent; Vital, Jean-Marc

    2012-02-01

    postoperative C2C7 alignment. No significant correlation was observed between ROM and sagittal parameters. Few correlations were found between sagittal alignment and clinical results. CDR with this prosthesis provided favorable clinical outcomes and maintains ROM of the FSU, overall and segmental cervical alignment. Long-term follow-up will be needed to assess the effectiveness and advantages of this procedure.

  19. Biennial-Aligned Lunisolar-Forcing of ENSO: Implications for Simplified Climate Models

    Science.gov (United States)

    Pukite, P. R.

    2017-12-01

    By solving Laplace's tidal equations along the equatorial Pacific thermocline, assuming a delayed-differential effective gravity forcing due to a combined lunar+solar (lunisolar) stimulus, we are able to precisely match ENSO periodic variations over wide intervals. The underlying pattern is difficult to decode by conventional means such as spectral analysis, which is why it has remained hidden for so long, despite the excellent agreement in the time-domain. What occurs is that a non-linear seasonal modulation with monthly and fortnightly lunar impulses along with a biennially-aligned "see-saw" is enough to cause a physical aliasing and thus multiple folding in the frequency spectrum. So, instead of a conventional spectral tidal decomposition, we opted for a time-domain cross-validating approach to calibrate the amplitude and phasing of the lunisolar cycles. As the lunar forcing consists of three fundamental periods (draconic, anomalistic, synodic), we used the measured Earth's length-of-day (LOD) decomposed and resolved at a monthly time-scale [1] to align the amplitude and phase precisely. Even slight variations from the known values of the long-period tides will degrade the fit, so a high-resolution calibration is possible. Moreover, a narrow training segment from 1880-1920 using NINO34/SOI data is adequate to extrapolate the cycles of the past 100 years (see attached figure). To further understand the biennial impact of a yearly differential-delay, we were able to also decompose using difference equations the historical sea-level-height readings at Sydney harbor to clearly expose the ENSO behavior. Finally, the ENSO lunisolar model was validated by back-extrapolating to Unified ENSO coral proxy (UEP) records dating to 1650. The quasi-biennial oscillation (QBO) behavior of equatorial stratospheric winds derives following a similar pattern to ENSO via the tidal equations, but with an emphasis on draconic forcing. This improvement in ENSO and QBO understanding has

  20. L2 Extensive Reading and Flow: Clarifying the Relationship

    Science.gov (United States)

    Kirchhoff, Cheryl

    2013-01-01

    Among foreign language educators interest in extensive reading is growing along with questions about learner motivation to read. Maintaining learner motivation over long periods of time is influenced by many variables suggesting that multiple means of stimulating motivation is needed. The psychological theory of flow has been suggested to…

  1. Background Adjusted Alignment-Free Dissimilarity Measures Improve the Detection of Horizontal Gene Transfer

    Directory of Open Access Journals (Sweden)

    Kujin Tang

    2018-04-01

    Full Text Available Horizontal gene transfer (HGT plays an important role in the evolution of microbial organisms including bacteria. Alignment-free methods based on single genome compositional information have been used to detect HGT. Currently, Manhattan and Euclidean distances based on tetranucleotide frequencies are the most commonly used alignment-free dissimilarity measures to detect HGT. By testing on simulated bacterial sequences and real data sets with known horizontal transferred genomic regions, we found that more advanced alignment-free dissimilarity measures such as CVTree and d2* that take into account the background Markov sequences can solve HGT detection problems with significantly improved performance. We also studied the influence of different factors such as evolutionary distance between host and donor sequences, size of sliding window, and host genome composition on the performances of alignment-free methods to detect HGT. Our study showed that alignment-free methods can predict HGT accurately when host and donor genomes are in different order levels. Among all methods, CVTree with word length of 3, d2* with word length 3, Markov order 1 and d2* with word length 4, Markov order 1 outperform others in terms of their highest F1-score and their robustness under the influence of different factors.

  2. De novo assembly of human genomes with massively parallel short read sequencing

    DEFF Research Database (Denmark)

    Li, Ruiqiang; Zhu, Hongmei; Ruan, Jue

    2010-01-01

    genomes from short read sequences. We successfully assembled both the Asian and African human genome sequences, achieving an N50 contig size of 7.4 and 5.9 kilobases (kb) and scaffold of 446.3 and 61.9 kb, respectively. The development of this de novo short read assembly method creates new opportunities...... for building reference sequences and carrying out accurate analyses of unexplored genomes in a cost-effective way....

  3. 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...

  4. Electroactive Tissue Scaffolds with Aligned Pores as Instructive Platforms for Biomimetic Tissue Engineering

    Directory of Open Access Journals (Sweden)

    John G. Hardy

    2015-01-01

    Full Text Available Tissues in the body are hierarchically structured composite materials with tissue-specific chemical and topographical properties. Here we report the preparation of tissue scaffolds with macroscopic pores generated via the dissolution of a sacrificial supramolecular polymer-based crystal template (urea from a biodegradable polymer-based scaffold (polycaprolactone, PCL. Furthermore, we report a method of aligning the supramolecular polymer-based crystals within the PCL, and that the dissolution of the sacrificial urea yields scaffolds with macroscopic pores that are aligned over long, clinically-relevant distances (i.e., centimeter scale. The pores act as topographical cues to which rat Schwann cells respond by aligning with the long axis of the pores. Generation of an interpenetrating network of polypyrrole (PPy and poly(styrene sulfonate (PSS in the scaffolds yields electroactive tissue scaffolds that allow the electrical stimulation of Schwann cells cultured on the scaffolds which increases the production of nerve growth factor (NGF.

  5. The Interdependence of Long- and Short-Term Components in Unmasked Repetition Priming: An Indication of Shared Resources.

    Science.gov (United States)

    Merema, Matt R; Speelman, Craig P

    2015-01-01

    It has been suggested that unmasked repetition priming is composed of distinct long-and short-term priming components. The current study sought to clarify the relationship between these components by examining the relationship between them. A total of 60 people (45 females, 15 males) participated in a computer-based lexical decision task designed to measure levels of short-term priming across different levels of long-term priming. The results revealed an interdependent relationship between the two components, whereby an increase in long-term priming prompted a decrease in short-term priming. Both long-term and short-term priming were accurately captured by a single power function over seven minutes post repetition, suggesting the two components may draw on the same resources. This interdependence between long- and short-term priming may serve to improve fluency in reading.

  6. The Interdependence of Long- and Short-Term Components in Unmasked Repetition Priming: An Indication of Shared Resources.

    Directory of Open Access Journals (Sweden)

    Matt R Merema

    Full Text Available It has been suggested that unmasked repetition priming is composed of distinct long-and short-term priming components. The current study sought to clarify the relationship between these components by examining the relationship between them. A total of 60 people (45 females, 15 males participated in a computer-based lexical decision task designed to measure levels of short-term priming across different levels of long-term priming. The results revealed an interdependent relationship between the two components, whereby an increase in long-term priming prompted a decrease in short-term priming. Both long-term and short-term priming were accurately captured by a single power function over seven minutes post repetition, suggesting the two components may draw on the same resources. This interdependence between long- and short-term priming may serve to improve fluency in reading.

  7. SPARSE: quadratic time simultaneous alignment and folding of RNAs without sequence-based heuristics.

    Science.gov (United States)

    Will, Sebastian; Otto, Christina; Miladi, Milad; Möhl, Mathias; Backofen, Rolf

    2015-08-01

    RNA-Seq experiments have revealed a multitude of novel ncRNAs. The gold standard for their analysis based on simultaneous alignment and folding suffers from extreme time complexity of [Formula: see text]. Subsequently, numerous faster 'Sankoff-style' approaches have been suggested. Commonly, the performance of such methods relies on sequence-based heuristics that restrict the search space to optimal or near-optimal sequence alignments; however, the accuracy of sequence-based methods breaks down for RNAs with sequence identities below 60%. Alignment approaches like LocARNA that do not require sequence-based heuristics, have been limited to high complexity ([Formula: see text] quartic time). Breaking this barrier, we introduce the novel Sankoff-style algorithm 'sparsified prediction and alignment of RNAs based on their structure ensembles (SPARSE)', which runs in quadratic time without sequence-based heuristics. To achieve this low complexity, on par with sequence alignment algorithms, SPARSE features strong sparsification based on structural properties of the RNA ensembles. Following PMcomp, SPARSE gains further speed-up from lightweight energy computation. Although all existing lightweight Sankoff-style methods restrict Sankoff's original model by disallowing loop deletions and insertions, SPARSE transfers the Sankoff algorithm to the lightweight energy model completely for the first time. Compared with LocARNA, SPARSE achieves similar alignment and better folding quality in significantly less time (speedup: 3.7). At similar run-time, it aligns low sequence identity instances substantially more accurate than RAF, which uses sequence-based heuristics. © The Author 2015. Published by Oxford University Press.

  8. 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...

  9. Developing reading literacy by reading badge

    OpenAIRE

    Rejc, Blanka

    2017-01-01

    Reading is a fundamental activity of our society and is present in all areas of a person’s life. Authors who deal with reading define reading with different definitions, some of them I also presented in my master’s degree thesis. The ways of reading, typology of readers and knowledge of different reading models are only some of the important theoretical facts that serve as a basis for the research and defining reading. Reading motivation is an important motivational factor, which encourages a...

  10. Leadership Distinctions: The Impact of Leadership on Teachers of "Second Chance Reading"

    Science.gov (United States)

    Williams, Rebecca Sue

    2012-01-01

    For as long as time, struggling adolescent readers have filled classrooms and communities. In many cases, these functional aliterates typically could read, yet could not understand or evaluate text, provide relevant details, or support inferences about the written documents they had read. "Second Chance Reading" (SCR), an instructional…

  11. Exploring the Relationship between Adolescent's Reading Skills, Reading Motivation and Reading Habits

    Science.gov (United States)

    McGeown, Sarah P.; Duncan, Lynne G.; Griffiths, Yvonne M.; Stothard, Sue E.

    2015-01-01

    The present study examines the extent to which adolescents' reading affect (reading motivation) and behaviour (reading habits) predict different components of reading (word reading, comprehension, summarisation and text reading speed) and also adds to the limited research examining group differences (gender, age, ability) in adolescents' reading…

  12. Lexical-Semantic Reading in a Shallow Orthography: Evidence from a Girl with Williams Syndrome

    Science.gov (United States)

    Barca, Laura; Bello, Arianna; Volterra, Virginia; Burani, Cristina

    2010-01-01

    The reading skills of a girl with Williams Syndrome are assessed by a timed word-naming task. To test the efficiency of lexical and nonlexical reading, we considered four marker effects: Lexicality (better reading of words than nonwords), frequency (better reading of high than low frequency words), length (better reading of short than long words),…

  13. Accuracy of home blood pressure readings: monitors and operators.

    Science.gov (United States)

    Stryker, Trina; Wilson, Merne; Wilson, Thomas W

    2004-06-01

    To evaluate the accuracy of automated digital blood pressure monitoring devices and operators in the community. Also, we tested the effects of a simple education program, and looked for arm-arm differences. Subjects who had bought their own automated digital blood pressure monitor were recruited via an advertisement in the local newspaper. On arrival, they were asked to record their blood pressure exactly as they would at home. The investigator noted any technique deficiencies then corrected them. Blood pressures were then recorded by the investigator and the subject, on opposite arms, simultaneously, and repeated with the arms switched. Finally, subjects recorded their blood pressure again. The subjects' readings were compared to the average of monitor and mercury readings using Bland-Altman methods. A total of 80 subjects were tested. Before educating, subjects' systolic blood pressure (SBP) readings were +5.8+/-6.4 (standard deviation) mmHg greater than the mean of all readings, and diastolic blood pressure (DBP) were +1.3+/-4.0 mmHg; after educating they were +1.3+/-4.0 and -1.3+/-2.7 respectively. The monitors, as a group, were accurate, and met British Hypertension Society and AAMI highest standards. We found no differences among monitors that had been validated (n=26) and those that had not. There were differences between the arms: 5.3+/-5.2 mmHg for SBP and 3.4+/-3.3 mmHg for DBP. Most patients had never been informed by anyone of proper blood pressure measuring techniques. We conclude that home blood pressure measurement, as practiced in our community, is prone to error, mostly due to mistakes by the operator. These can easily be corrected, so that readings become more accurate. Attention should be paid to arm-arm differences.

  14. Comprehensive Use of Curvature for Robust and Accurate Online Surface Reconstruction.

    Science.gov (United States)

    Lefloch, Damien; Kluge, Markus; Sarbolandi, Hamed; Weyrich, Tim; Kolb, Andreas

    2017-12-01

    Interactive real-time scene acquisition from hand-held depth cameras has recently developed much momentum, enabling applications in ad-hoc object acquisition, augmented reality and other fields. A key challenge to online reconstruction remains error accumulation in the reconstructed camera trajectory, due to drift-inducing instabilities in the range scan alignments of the underlying iterative-closest-point (ICP) algorithm. Various strategies have been proposed to mitigate that drift, including SIFT-based pre-alignment, color-based weighting of ICP pairs, stronger weighting of edge features, and so on. In our work, we focus on surface curvature as a feature that is detectable on range scans alone and hence does not depend on accurate multi-sensor alignment. In contrast to previous work that took curvature into consideration, however, we treat curvature as an independent quantity that we consistently incorporate into every stage of the real-time reconstruction pipeline, including densely curvature-weighted ICP, range image fusion, local surface reconstruction, and rendering. Using multiple benchmark sequences, and in direct comparison to other state-of-the-art online acquisition systems, we show that our approach significantly reduces drift, both when analyzing individual pipeline stages in isolation, as well as seen across the online reconstruction pipeline as a whole.

  15. ATLAS Inner Detector Alignment Performance with February 2015 Cosmic Rays Data

    CERN Document Server

    The ATLAS collaboration

    2015-01-01

    Results of the first alignment of the new insertable B-Layer, which was installed during the first long shutdown, are presented. These results were obtained by using cosmic ray data collected in February 2015. Different alignment techniques have been used to improve the description of the detector geometry. After the alignment, biases in the track-to-hit residuals in cosmic ray data events have been corrected, and the improvement of the active modules resolution is quantified in terms of the Full Width Half Maximum figures of merit. The IBL global position has been determined at micron level with an averaged module resolution of 32 $\\mu$m along the most sensitive direction of the module. Track parameters resolution has been studied using reconstructed split tracks.

  16. Precise alignment of the collection fiber assisted by real-time plasma imaging in laser-induced breakdown spectroscopy

    Energy Technology Data Exchange (ETDEWEB)

    Motto-Ros, V., E-mail: vincent.motto-ros@univ-lyon1.fr [Institut Lumière Matière, UMR 5306 Université Lyon 1-CNRS, Université de Lyon, 69622 Villeurbanne cedex (France); Negre, E. [Institut Lumière Matière, UMR 5306 Université Lyon 1-CNRS, Université de Lyon, 69622 Villeurbanne cedex (France); CRITT Matériaux Alsace, 19, rue de St Junien, 67305 Schiltigheim (France); Pelascini, F. [CRITT Matériaux Alsace, 19, rue de St Junien, 67305 Schiltigheim (France); Panczer, G.; Yu, J. [Institut Lumière Matière, UMR 5306 Université Lyon 1-CNRS, Université de Lyon, 69622 Villeurbanne cedex (France)

    2014-02-01

    Improving the repeatability and the reproducibility of measurement with laser-induced breakdown spectroscopy (LIBS) is one of the actual challenging issues faced by the technique to fit the requirements of precise and accurate quantitative analysis. Among the numerous factors influencing the measurement stability in short and long terms, there are shot-to-shot and day-to-day fluctuations of the morphology of the plasma. Such fluctuations are due to the high sensitivity of laser-induced plasma to experimental conditions including properties of the sample, the laser parameters as well as properties of the ambient gas. In this paper, we demonstrate that precise alignment of the optical fiber for the collection of the plasma emission with respect to the actual morphology of the plasma assisted by real-time imaging, greatly improves the stability of LIBS measurements in short as well as in long terms. The used setup is based on a plasma imaging arrangement using a CCD camera and a real-time image processing. The obtained plasma image is displayed in a 2-dimensional frame where the position of the optical fiber is beforehand calibrated. In addition, the setup provides direct sample surface monitoring, which allows a precise control of the distance between the focusing lens and the sample surface. Test runs with a set of 8 reference samples show very high determination coefficient for calibration curves (R{sup 2} = 0.9999), and a long term repeatability and reproducibility of 4.6% (relative standard deviation) over a period of 3 months without any signal normalization. The capacity of the system to automatically correct the sample surface position for a tilted or non-regular sample surface during a surface mapping measurement is also demonstrated. - Highlights: • Automated alignment of the collection fiber by real-time plasma imaging • High level control of experimental parameters in LIBS experiments • Improvement of the short and long term stability in LIBS

  17. Precise alignment of the collection fiber assisted by real-time plasma imaging in laser-induced breakdown spectroscopy

    International Nuclear Information System (INIS)

    Motto-Ros, V.; Negre, E.; Pelascini, F.; Panczer, G.; Yu, J.

    2014-01-01

    Improving the repeatability and the reproducibility of measurement with laser-induced breakdown spectroscopy (LIBS) is one of the actual challenging issues faced by the technique to fit the requirements of precise and accurate quantitative analysis. Among the numerous factors influencing the measurement stability in short and long terms, there are shot-to-shot and day-to-day fluctuations of the morphology of the plasma. Such fluctuations are due to the high sensitivity of laser-induced plasma to experimental conditions including properties of the sample, the laser parameters as well as properties of the ambient gas. In this paper, we demonstrate that precise alignment of the optical fiber for the collection of the plasma emission with respect to the actual morphology of the plasma assisted by real-time imaging, greatly improves the stability of LIBS measurements in short as well as in long terms. The used setup is based on a plasma imaging arrangement using a CCD camera and a real-time image processing. The obtained plasma image is displayed in a 2-dimensional frame where the position of the optical fiber is beforehand calibrated. In addition, the setup provides direct sample surface monitoring, which allows a precise control of the distance between the focusing lens and the sample surface. Test runs with a set of 8 reference samples show very high determination coefficient for calibration curves (R 2 = 0.9999), and a long term repeatability and reproducibility of 4.6% (relative standard deviation) over a period of 3 months without any signal normalization. The capacity of the system to automatically correct the sample surface position for a tilted or non-regular sample surface during a surface mapping measurement is also demonstrated. - Highlights: • Automated alignment of the collection fiber by real-time plasma imaging • High level control of experimental parameters in LIBS experiments • Improvement of the short and long term stability in LIBS measurements

  18. The accuracy of intramedullary tibial guide of sagittal alignment of PCL-substituting total knee arthroplasty.

    Science.gov (United States)

    Han, Hyuk-Soo; Kang, Seung-Baik; Jo, Chris H; Kim, Sun-Hong; Lee, Jung-Ha

    2010-10-01

    Experimental and clinical studies on the accuracy of the intramedullary alignment method have produced different results, and few have addressed accuracy in the sagittal plane. Reported deviations are not only attributable to the alignment method but also to radiological errors. The purpose of this study was to evaluate the accuracy of the intramedullary alignment method in the sagittal plane using computed tomography (CT) and 3-dimensional imaging software. Thirty-one TKAs were performed using an intramedullary alignment method involving the insertion of a long 8-mm diameter rod into the medullary canal to the distal metaphysis of the tibia. All alignment instruments were set to achieve an ideal varus/valgus angle of 0° in the coronal plane and a tibial slope of 0° in the sagittal plane. The accuracy of the intramedullary alignment system was assessed by measuring the coronal tibial component angle and sagittal tibial slope angles, i.e., angles between the tibial anatomical axis and the tangent to the medial and lateral tibial plateau or the cut-surface. The mean coronal tibial component angle was 88.5° ± 1.2° and the mean tibial component slope in the sagittal plane was 1.6° ± 1.2° without anterior slope. Our intramedullary tibial alignment method, which involves passing an 8-mm diameter long rod through the tibial shaft isthmus, showed good accuracy (less than 3 degrees of variation and no anterior slope) in the sagittal plane in neutral or varus knees.

  19. Sub-micron accurate track navigation method ''Navi'' for the analysis of Nuclear Emulsion

    International Nuclear Information System (INIS)

    Yoshioka, T; Yoshida, J; Kodama, K

    2011-01-01

    Sub-micron accurate track navigation in Nuclear Emulsion is realized by using low energy signals detected by automated Nuclear Emulsion read-out systems. Using those much dense ''noise'', about 10 4 times larger than the real tracks, the accuracy of the track position navigation reaches to be sub micron only by using the information of a microscope field of view, 200 micron times 200 micron. This method is applied to OPERA analysis in Japan, i.e. support of human eye checks of the candidate tracks, confirmation of neutrino interaction vertexes and to embed missing track segments to the track data read-out by automated systems.

  20. Sub-micron accurate track navigation method ``Navi'' for the analysis of Nuclear Emulsion

    Science.gov (United States)

    Yoshioka, T.; Yoshida, J.; Kodama, K.

    2011-03-01

    Sub-micron accurate track navigation in Nuclear Emulsion is realized by using low energy signals detected by automated Nuclear Emulsion read-out systems. Using those much dense ``noise'', about 104 times larger than the real tracks, the accuracy of the track position navigation reaches to be sub micron only by using the information of a microscope field of view, 200 micron times 200 micron. This method is applied to OPERA analysis in Japan, i.e. support of human eye checks of the candidate tracks, confirmation of neutrino interaction vertexes and to embed missing track segments to the track data read-out by automated systems.

  1. 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...

  2. Multiciliated cell basal bodies align in stereotypical patterns coordinated by the apical cytoskeleton

    Science.gov (United States)

    Herawati, Elisa; Kanoh, Hatsuho

    2016-01-01

    Multiciliated cells (MCCs) promote fluid flow through coordinated ciliary beating, which requires properly organized basal bodies (BBs). Airway MCCs have large numbers of BBs, which are uniformly oriented and, as we show here, align linearly. The mechanism for BB alignment is unexplored. To study this mechanism, we developed a long-term and high-resolution live-imaging system and used it to observe green fluorescent protein–centrin2–labeled BBs in cultured mouse tracheal MCCs. During MCC differentiation, the BB array adopted four stereotypical patterns, from a clustering “floret” pattern to the linear “alignment.” This alignment process was correlated with BB orientations, revealed by double immunostaining for BBs and their asymmetrically associated basal feet (BF). The BB alignment was disrupted by disturbing apical microtubules with nocodazole and by a BF-depleting Odf2 mutation. We constructed a theoretical model, which indicated that the apical cytoskeleton, acting like a viscoelastic fluid, provides a self-organizing mechanism in tracheal MCCs to align BBs linearly for mucociliary transport. PMID:27573463

  3. 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...

  4. 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

  5. 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

  6. I read, you read, we read: the history of reading in Slovenia

    Directory of Open Access Journals (Sweden)

    Anja Dular

    2013-03-01

    Full Text Available ABSTRACTPurpose: The aim of the article is to research reading habits in Slovenia in the period between 16th and 19th century and to find similarities with Austria and other European countries of that time.Methodology/approach: For the purpose of the analysis different resources were used – study books, catechisms, prayer books and manuals. We were focused on introductions in which readers are advised how to read, explaining to whom the work is intended and emphasizing the importance of meditation on the texts.Results: Historically the laud reading was prefered, as to continue the folk tradition. However, the 16th century texts were transmitted by women while the folk tradition was narrated by males. In the 18th century the higher level of literacy and greater book production and availability caused that the books were not a privilege of a few. At that time more texts were intended for silent, individual reading. Interestingly, the authors emphasized the importance of meditation on the texts, too. It was also advised when to read – it wasrecommedend to read in leisure time on Sundays, and on holidays. The role of books was also to breakaway with the reality and to forget everyday problems. Due to the overproduction of books in the 17th centrury it was concerned that books are misleading the crowds. The church considered the reading of books as inappropriate, and criticized fiction, novels and adventure stories mostly read by women.Research limitation: The study is based on Slovenian texts only, although the foreign literature, especially in German, was generally available, too.Originality/practical implications: The study is fullfiling the gap in the history of reading in Slovenia.

  7. Orientation dependent band alignment for p-NiO/n-ZnO heterojunctions

    International Nuclear Information System (INIS)

    Ma, M. J.; Lu, B.; Zhou, T. T.; Ye, Z. Z.; Lu, J. G.; Pan, X. H.

    2013-01-01

    Nonpolor a-plane and polar c-plane ZnO thin films were prepared on r-plane sapphire and quartz substrates, respectively. The electronic structure of the interface between subsequently fabricated NiO/ZnO heterojunctions has been investigated by x-ray photoelectron spectroscopy measurements and the band offsets are determined together with information yielded from UV-vis transition spectra. It is found that a type-II band alignment forms at the interface for both the samples. The revealed ZnO-orientation dependent band offsets are analyzed and are attributed mainly due to the variations in internal electric field arose from spontaneous polarization effect. The accurate determination of the band alignment is important for the design and application of NiO/ZnO based hybrid devices.

  8. Orientation dependent band alignment for p-NiO/n-ZnO heterojunctions

    Energy Technology Data Exchange (ETDEWEB)

    Ma, M. J.; Lu, B.; Zhou, T. T.; Ye, Z. Z.; Lu, J. G.; Pan, X. H. [State Key Laboratory of Silicon Materials, Cyrus Tang Center for Sensor Materials and Applications, Department of Materials Science and Engineering, Zhejiang University, Hangzhou 310027 (China)

    2013-04-28

    Nonpolor a-plane and polar c-plane ZnO thin films were prepared on r-plane sapphire and quartz substrates, respectively. The electronic structure of the interface between subsequently fabricated NiO/ZnO heterojunctions has been investigated by x-ray photoelectron spectroscopy measurements and the band offsets are determined together with information yielded from UV-vis transition spectra. It is found that a type-II band alignment forms at the interface for both the samples. The revealed ZnO-orientation dependent band offsets are analyzed and are attributed mainly due to the variations in internal electric field arose from spontaneous polarization effect. The accurate determination of the band alignment is important for the design and application of NiO/ZnO based hybrid devices.

  9. Developmental, Component-Based Model of Reading Fluency: An Investigation of Predictors of Word-Reading Fluency, Text-Reading Fluency, and Reading Comprehension.

    Science.gov (United States)

    Kim, Young-Suk Grace

    2015-01-01

    The primary goal was to expand our understanding of text reading fluency (efficiency or automaticity)-how its relation to other constructs (e.g., word reading fluency and reading comprehension) changes over time and how it is different from word reading fluency and reading comprehension. We examined (1) developmentally changing relations among word reading fluency, listening comprehension, text reading fluency, and reading comprehension; (2) the relation of reading comprehension to text reading fluency; (3) unique emergent literacy predictors (i.e., phonological awareness, orthographic awareness, morphological awareness, letter name knowledge, vocabulary) of text reading fluency vs. word reading fluency; and (4) unique language and cognitive predictors (e.g., vocabulary, grammatical knowledge, theory of mind) of text reading fluency vs. reading comprehension. These questions were addressed using longitudinal data (two timepoints; Mean age = 5;24 & 6;08) from Korean-speaking children ( N = 143). Results showed that listening comprehension was related to text reading fluency at time 2, but not at time 1. At both times text reading fluency was related to reading comprehension, and reading comprehension was related to text reading fluency over and above word reading fluency and listening comprehension. Orthographic awareness was related to text reading fluency over and above other emergent literacy skills and word reading fluency. Vocabulary and grammatical knowledge were independently related to text reading fluency and reading comprehension whereas theory of mind was related to reading comprehension, but not text reading fluency. These results reveal developmental nature of relations and mechanism of text reading fluency in reading development.

  10. Concept of AHRS Algorithm Designed for Platform Independent Imu Attitude Alignment

    Science.gov (United States)

    Tomaszewski, Dariusz; Rapiński, Jacek; Pelc-Mieczkowska, Renata

    2017-12-01

    Nowadays, along with the advancement of technology one can notice the rapid development of various types of navigation systems. So far the most popular satellite navigation, is now supported by positioning results calculated with use of other measurement system. The method and manner of integration will depend directly on the destination of system being developed. To increase the frequency of readings and improve the operation of outdoor navigation systems, one will support satellite navigation systems (GPS, GLONASS ect.) with inertial navigation. Such method of navigation consists of several steps. The first stage is the determination of initial orientation of inertial measurement unit, called INS alignment. During this process, on the basis of acceleration and the angular velocity readings, values of Euler angles (pitch, roll, yaw) are calculated allowing for unambiguous orientation of the sensor coordinate system relative to external coordinate system. The following study presents the concept of AHRS (Attitude and heading reference system) algorithm, allowing to define the Euler angles.The study were conducted with the use of readings from low-cost MEMS cell phone sensors. Subsequently the results of the study were analyzed to determine the accuracy of featured algorithm. On the basis of performed experiments the legitimacy of developed algorithm was stated.

  11. Two Influential Primate Classifications Logically Aligned.

    Science.gov (United States)

    Franz, Nico M; Pier, Naomi M; Reeder, Deeann M; Chen, Mingmin; Yu, Shizhuo; Kianmajd, Parisa; Bowers, Shawn; Ludäscher, Bertram

    2016-07-01

    Classifications and phylogenies of perceived natural entities change in the light of new evidence. Taxonomic changes, translated into Code-compliant names, frequently lead to name:meaning dissociations across succeeding treatments. Classification standards such as the Mammal Species of the World (MSW) may experience significant levels of taxonomic change from one edition to the next, with potential costs to long-term, large-scale information integration. This circumstance challenges the biodiversity and phylogenetic data communities to express taxonomic congruence and incongruence in ways that both humans and machines can process, that is, to logically represent taxonomic alignments across multiple classifications. We demonstrate that such alignments are feasible for two classifications of primates corresponding to the second and third MSW editions. Our approach has three main components: (i) use of taxonomic concept labels, that is name sec. author (where sec. means according to), to assemble each concept hierarchy separately via parent/child relationships; (ii) articulation of select concepts across the two hierarchies with user-provided Region Connection Calculus (RCC-5) relationships; and (iii) the use of an Answer Set Programming toolkit to infer and visualize logically consistent alignments of these input constraints. Our use case entails the Primates sec. Groves (1993; MSW2-317 taxonomic concepts; 233 at the species level) and Primates sec. Groves (2005; MSW3-483 taxonomic concepts; 376 at the species level). Using 402 RCC-5 input articulations, the reasoning process yields a single, consistent alignment and 153,111 Maximally Informative Relations that constitute a comprehensive meaning resolution map for every concept pair in the Primates sec. MSW2/MSW3. The complete alignment, and various partitions thereof, facilitate quantitative analyses of name:meaning dissociation, revealing that nearly one in three taxonomic names are not reliable across treatments

  12. Validation of a Supplemental Reading Intervention for First-Grade Children

    Science.gov (United States)

    Case, Lisa Pericola; Speece, Deborah L.; Silverman, Rebecca; Ritchey, Kristen D.; Schatschneider, Christopher; Cooper, David H.; Montanaro, Elizabeth; Jacobs, Dawn

    2010-01-01

    This experimental study was designed to validate a short-term supplemental reading intervention for at-risk first-grade children. Although substantial research on long-term supplemental reading interventions exists, less is known about short-term interventions. Thirty first-grade children were randomly assigned to intervention or control…

  13. Does Extensive Reading Promote Reading Speed?

    Science.gov (United States)

    He, Mu

    2014-01-01

    Research has shown a wide range of learning benefits accruing from extensive reading. Not only is there improvement in reading, but also in a wide range of language uses and areas of language knowledge. However, few research studies have examined reading speed. The existing literature on reading speed focused on students' reading speed without…

  14. Accuracy of target localisation and alignment in stereotactic radiosurgery at Royal Prince Alfred Hospital

    International Nuclear Information System (INIS)

    Downes, S.

    1996-01-01

    Full text: Over the last 30 years, stereotactic radiosurgery has become an effective clinical tool in the treatment of intra-cranial lesions. The use of high doses to a specific target volume in a single fraction and the proximity of critical organs requires very accurate geometric localisation of the various cranial structures (using CT, MRI and angiography imaging) and accurate alignment of the target volume prior to treatment. The purpose of this paper was to determine the accuracy of localising cranial structures using computed tomography and angiographic imaging modalities and to determine the accuracy of aligning the treatment isocentre to the specified coordinates. The sum of these two errors will give the total deviation of the treated target from the actual target. Measurements were made using an anthropomorphic (ART) phantom of an adult male and a cerrobend target. The ART phantom was immobilised using the Brown-Roberts-Wells (BRW) ring. The cerrobend target was inserted into the skull at 10 different positions. Each of these 10 positions were scanned using CT and angiographic imaging and localised using the stereotactic planning software. For each test position, the ART phantom was placed on the treatment couch and aligned to the treatment coordinates determined using localisation (CT and angiography). A-P and lateral port films were then made of the target. The distance between the centre of the cerrobend target (intended target) and the centre of radiation (actual target) was the total error in localisation and alignment of the target. For computed tomography, the measurements showed the average error in localisation and alignment of the target was ±0.7mm. In terms of coordinate axis, the average error was: A-P axis = ±0.5mm, Lateral(left-right) Axis = ±0.3mm, Vertical(inferior superior) Axis ±0.4mm. From these measurements it was shown that using the stereotactic radiosurgery planning system and hardware, cranial lesions could be localised and

  15. The standard centrifuge method accurately measures vulnerability curves of long-vesselled olive stems.

    Science.gov (United States)

    Hacke, Uwe G; Venturas, Martin D; MacKinnon, Evan D; Jacobsen, Anna L; Sperry, John S; Pratt, R Brandon

    2015-01-01

    The standard centrifuge method has been frequently used to measure vulnerability to xylem cavitation. This method has recently been questioned. It was hypothesized that open vessels lead to exponential vulnerability curves, which were thought to be indicative of measurement artifact. We tested this hypothesis in stems of olive (Olea europea) because its long vessels were recently claimed to produce a centrifuge artifact. We evaluated three predictions that followed from the open vessel artifact hypothesis: shorter stems, with more open vessels, would be more vulnerable than longer stems; standard centrifuge-based curves would be more vulnerable than dehydration-based curves; and open vessels would cause an exponential shape of centrifuge-based curves. Experimental evidence did not support these predictions. Centrifuge curves did not vary when the proportion of open vessels was altered. Centrifuge and dehydration curves were similar. At highly negative xylem pressure, centrifuge-based curves slightly overestimated vulnerability compared to the dehydration curve. This divergence was eliminated by centrifuging each stem only once. The standard centrifuge method produced accurate curves of samples containing open vessels, supporting the validity of this technique and confirming its utility in understanding plant hydraulics. Seven recommendations for avoiding artefacts and standardizing vulnerability curve methodology are provided. © 2014 The Authors. New Phytologist © 2014 New Phytologist Trust.

  16. Automatic frequency and phase alignment of in vivo J-difference-edited MR spectra by frequency domain correlation.

    Science.gov (United States)

    Wiegers, Evita C; Philips, Bart W J; Heerschap, Arend; van der Graaf, Marinette

    2017-12-01

    J-difference editing is often used to select resonances of compounds with coupled spins in 1 H-MR spectra. Accurate phase and frequency alignment prior to subtracting J-difference-edited MR spectra is important to avoid artefactual contributions to the edited resonance. In-vivo J-difference-edited MR spectra were aligned by maximizing the normalized scalar product between two spectra (i.e., the correlation over a spectral region). The performance of our correlation method was compared with alignment by spectral registration and by alignment of the highest point in two spectra. The correlation method was tested at different SNR levels and for a broad range of phase and frequency shifts. In-vivo application of the proposed correlation method showed reduced subtraction errors and increased fit reliability in difference spectra as compared with conventional peak alignment. The correlation method and the spectral registration method generally performed equally well. However, better alignment using the correlation method was obtained for spectra with a low SNR (down to ~2) and for relatively large frequency shifts. Our correlation method for simultaneously phase and frequency alignment is able to correct both small and large phase and frequency drifts and also performs well at low SNR levels.

  17. 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.

  18. MetAlign: Interface-Driven, Versatile Metabolomics Tool for Hyphenated Full-Scan Mass Spectrometry Data Preprocessing

    NARCIS (Netherlands)

    Lommen, A.

    2009-01-01

    Hyphenated full-scan MS technology creates large amounts of data. A versatile easy to handle automation tool aiding in the data analysis is very important in handling such a data stream. MetAlign software-as described in this manuscript-handles a broad range of accurate mass and nominal mass GC/MS

  19. SPARSE: quadratic time simultaneous alignment and folding of RNAs without sequence-based heuristics

    Science.gov (United States)

    Will, Sebastian; Otto, Christina; Miladi, Milad; Möhl, Mathias; Backofen, Rolf

    2015-01-01

    Motivation: RNA-Seq experiments have revealed a multitude of novel ncRNAs. The gold standard for their analysis based on simultaneous alignment and folding suffers from extreme time complexity of O(n6). Subsequently, numerous faster ‘Sankoff-style’ approaches have been suggested. Commonly, the performance of such methods relies on sequence-based heuristics that restrict the search space to optimal or near-optimal sequence alignments; however, the accuracy of sequence-based methods breaks down for RNAs with sequence identities below 60%. Alignment approaches like LocARNA that do not require sequence-based heuristics, have been limited to high complexity (≥ quartic time). Results: Breaking this barrier, we introduce the novel Sankoff-style algorithm ‘sparsified prediction and alignment of RNAs based on their structure ensembles (SPARSE)’, which runs in quadratic time without sequence-based heuristics. To achieve this low complexity, on par with sequence alignment algorithms, SPARSE features strong sparsification based on structural properties of the RNA ensembles. Following PMcomp, SPARSE gains further speed-up from lightweight energy computation. Although all existing lightweight Sankoff-style methods restrict Sankoff’s original model by disallowing loop deletions and insertions, SPARSE transfers the Sankoff algorithm to the lightweight energy model completely for the first time. Compared with LocARNA, SPARSE achieves similar alignment and better folding quality in significantly less time (speedup: 3.7). At similar run-time, it aligns low sequence identity instances substantially more accurate than RAF, which uses sequence-based heuristics. Availability and implementation: SPARSE is freely available at http://www.bioinf.uni-freiburg.de/Software/SPARSE. Contact: backofen@informatik.uni-freiburg.de Supplementary information: Supplementary data are available at Bioinformatics online. PMID:25838465

  20. Reading, Laterality, and the Brain: Early Contributions on Reading Disabilities by Sara S. Sparrow

    Science.gov (United States)

    Fletcher, Jack M.; Morris, Robin D.

    2014-01-01

    Although best known for work with children and adults with intellectual disabilities and autism spectrum disorders, training in speech pathology and a doctorate in clinical psychology and neuropsychology was the foundation for Sara Sparrow's long-term interest in reading disabilities. Her first papers were on dyslexia and laterality, and the…

  1. 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.

  2. Precision alignment and calibration of optical systems using computer generated holograms

    Science.gov (United States)

    Coyle, Laura Elizabeth

    As techniques for manufacturing and metrology advance, optical systems are being designed with more complexity than ever before. Given these prescriptions, alignment and calibration can be a limiting factor in their final performance. Computer generated holograms (CGHs) have several unique properties that make them powerful tools for meeting these demanding tolerances. This work will present three novel methods for alignment and calibration of optical systems using computer generated holograms. Alignment methods using CGHs require that the optical wavefront created by the CGH be related to a mechanical datum to locate it space. An overview of existing methods is provided as background, then two new alignment methods are discussed in detail. In the first method, the CGH contact Ball Alignment Tool (CBAT) is used to align a ball or sphere mounted retroreflector (SMR) to a Fresnel zone plate pattern with micron level accuracy. The ball is bonded directly onto the CGH substrate and provides permanent, accurate registration between the optical wavefront and a mechanical reference to locate the CGH in space. A prototype CBAT was built and used to align and bond an SMR to a CGH. In the second method, CGH references are used to align axi-symmetric optics in four degrees of freedom with low uncertainty and real time feedback. The CGHs create simultaneous 3D optical references where the zero order reflection sets tilt and the first diffracted order sets centration. The flexibility of the CGH design can be used to accommodate a wide variety of optical systems and maximize sensitivity to misalignments. A 2-CGH prototype system was aligned multiplied times and the alignment uncertainty was quantified and compared to an error model. Finally, an enhanced calibration method is presented. It uses multiple perturbed measurements of a master sphere to improve the calibration of CGH-based Fizeau interferometers ultimately measuring aspheric test surfaces. The improvement in the

  3. Lip-reading enhancement for law enforcement

    Science.gov (United States)

    Theobald, Barry J.; Harvey, Richard; Cox, Stephen J.; Lewis, Colin; Owen, Gari P.

    2006-09-01

    Accurate lip-reading techniques would be of enormous benefit for agencies involved in counter-terrorism and other law-enforcement areas. Unfortunately, there are very few skilled lip-readers, and it is apparently a difficult skill to transmit, so the area is under-resourced. In this paper we investigate the possibility of making the lip-reading task more amenable to a wider range of operators by enhancing lip movements in video sequences using active appearance models. These are generative, parametric models commonly used to track faces in images and video sequences. The parametric nature of the model allows a face in an image to be encoded in terms of a few tens of parameters, while the generative nature allows faces to be re-synthesised using the parameters. The aim of this study is to determine if exaggerating lip-motions in video sequences by amplifying the parameters of the model improves lip-reading ability. We also present results of lip-reading tests undertaken by experienced (but non-expert) adult subjects who claim to use lip-reading in their speech recognition process. The results, which are comparisons of word error-rates on unprocessed and processed video, are mixed. We find that there appears to be the potential to improve the word error rate but, for the method to improve the intelligibility there is need for more sophisticated tracking and visual modelling. Our technique can also act as an expression or visual gesture amplifier and so has applications to animation and the presentation of information via avatars or synthetic humans.

  4. The effect of extensive reading and paired-associate learning on long-term vocabulary retention: an event-related potential study.

    Science.gov (United States)

    Chun, Eunjin; Choi, Sungmook; Kim, Junsoo

    2012-07-19

    We investigated the relative efficacy of extensive reading (ER) and paired-associate learning (PAL) in the ability of second language (L2) learners to retain new vocabulary words. To that end, we combined behavioral measures (i.e., vocabulary tests) and an event-related potential (ERP) investigation with a focus on the N400 ERP component to track short- and long-term vocabulary retention as a consequence of the two different approaches. Behavioral results indicated that both ER and PAL led to substantial short-term retention of the target words. In contrast, on a long-term basis, ER was more effective than PAL to a considerable degree as indicated by a large-size effect (d=1.35). Evidence from the N400 effects (d=1.70) observed in the parietal electrode group (P3, Pz, P4) provided further support for the superior effects of ER over PAL on long-term vocabulary retention. The converging evidence challenges the assumptions of some L2 researchers and makes a significant contribution to the literature of vocabulary acquisition, because it provides the first ERP evidence that ER is more conducive to long-term vocabulary retention than PAL. Copyright © 2012 Elsevier Ireland Ltd. All rights reserved.

  5. 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...

  6. 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...

  7. Evaluating the Portuguese National Reading Plan: Teachers' Perceptions on the Impact in Schools

    Science.gov (United States)

    da Costa, António Firmino; Pegado, Elsa; Ávila, Patrícia; Coelho, Ana Rita

    2015-01-01

    This article focuses on teachers' perceptions of the implementation and impact in Portuguese schools of a wide-ranging and long-term reading promotion programme. The Portuguese National Reading Plan (PNRP) was a public policy initiative whose purpose was to increase literacy levels and reading habits among the population. The Plan identified…

  8. Band Alignment Determination of Two-Dimensional Heterojunctions and Their Electronic Applications

    KAUST Repository

    Chiu, Ming-Hui

    2018-05-09

    Two-dimensional (2D) layered materials such as MoS2 have been recognized as high on-off ratio semiconductors which are promising candidates for electronic and optoelectronic devices. In addition to the use of individual 2D materials, the accelerated field of 2D heterostructures enables even greater functionalities. Device designs differ, and they are strongly controlled by the electronic band alignment. For example, photovoltaic cells require type II heterostructures for light harvesting, and light-emitting diodes benefit from multiple quantum wells with the type I band alignment for high emission efficiency. The vertical tunneling field-effect transistor for next-generation electronics depends on nearly broken-gap band alignment for boosting its performance. To tailor these 2D layered materials toward possible future applications, the understanding of 2D heterostructure band alignment becomes critically important. In the first part of this thesis, we discuss the band alignment of 2D heterostructures. To do so, we firstly study the interlayer coupling between two dissimilar 2D materials. We conclude that a post-anneal process could enhance the interlayer coupling of as-transferred 2D heterostructures, and heterostructural stacking imposes similar symmetry changes as homostructural stacking. Later, we precisely determine the quasi particle bandgap and band alignment of the MoS2/WSe2 heterostructure by using scan tunneling microscopy/spectroscopy (STM/S) and micron-beam X-ray photoelectron spectroscopy (μ-XPS) techniques. Lastly, we prove that the band alignment of 2D heterojunctions can be accurately predicted by Anderson’s model, which has previously failed to predict conventional bulk heterostructures. In the second part of this thesis, we develop a new Chemical Vapor Deposition (CVD) method capable of precisely controlling the growth area of p- and n-type transition metal dichalcogenides (TMDCs) and further form lateral or vertical 2D heterostructures. This

  9. Foreign language reading and spelling in gifted students with dyslexia in secondary education

    OpenAIRE

    van Viersen, Sietske; de Bree, Elise H.; Kalee, Lilian; Kroesbergen, Evelyn H.; de Jong, Peter F.

    2017-01-01

    A few studies suggest that gifted children with dyslexia have better literacy skills than averagely intelligent children with dyslexia. This finding aligns with the hypothesis that giftedness-related factors provide compensation for poor reading. The present study investigated whether, as in the native language (NL), the level of foreign language (FL) literacy of gifted students with dyslexia is higher than the literacy level of averagely intelligent students with dyslexia and whether this di...

  10. An information propagation model considering incomplete reading behavior in microblog

    Science.gov (United States)

    Su, Qiang; Huang, Jiajia; Zhao, Xiande

    2015-02-01

    Microblog is one of the most popular communication channels on the Internet, and has already become the third largest source of news and public opinions in China. Although researchers have studied the information propagation in microblog using the epidemic models, previous studies have not considered the incomplete reading behavior among microblog users. Therefore, the model cannot fit the real situations well. In this paper, we proposed an improved model entitled Microblog-Susceptible-Infected-Removed (Mb-SIR) for information propagation by explicitly considering the user's incomplete reading behavior. We also tested the effectiveness of the model using real data from Sina Microblog. We demonstrate that the new proposed model is more accurate in describing the information propagation in microblog. In addition, we also investigate the effects of the critical model parameters, e.g., reading rate, spreading rate, and removed rate through numerical simulations. The simulation results show that, compared with other parameters, reading rate plays the most influential role in the information propagation performance in microblog.

  11. Developmental, Component-Based Model of Reading Fluency: An Investigation of Predictors of Word-Reading Fluency, Text-Reading Fluency, and Reading Comprehension

    OpenAIRE

    Kim, Young-Suk Grace

    2015-01-01

    The primary goal was to expand our understanding of text reading fluency (efficiency or automaticity)—how its relation to other constructs (e.g., word reading fluency and reading comprehension) changes over time and how it is different from word reading fluency and reading comprehension. We examined (1) developmentally changing relations among word reading fluency, listening comprehension, text reading fluency, and reading comprehension; (2) the relation of reading comprehension to text readi...

  12. 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

  13. A fast fiducial marker tracking model for fully automatic alignment in electron tomography

    KAUST Repository

    Han, Renmin; Zhang, Fa; Gao, Xin

    2017-01-01

    Automatic alignment, especially fiducial marker-based alignment, has become increasingly important due to the high demand of subtomogram averaging and the rapid development of large-field electron microscopy. Among the alignment steps, fiducial marker tracking is a crucial one that determines the quality of the final alignment. Yet, it is still a challenging problem to track the fiducial markers accurately and effectively in a fully automatic manner.In this paper, we propose a robust and efficient scheme for fiducial marker tracking. Firstly, we theoretically prove the upper bound of the transformation deviation of aligning the positions of fiducial markers on two micrographs by affine transformation. Secondly, we design an automatic algorithm based on the Gaussian mixture model to accelerate the procedure of fiducial marker tracking. Thirdly, we propose a divide-and-conquer strategy against lens distortions to ensure the reliability of our scheme. To our knowledge, this is the first attempt that theoretically relates the projection model with the tracking model. The real-world experimental results further support our theoretical bound and demonstrate the effectiveness of our algorithm. This work facilitates the fully automatic tracking for datasets with a massive number of fiducial markers.The C/C ++ source code that implements the fast fiducial marker tracking is available at https://github.com/icthrm/gmm-marker-tracking. Markerauto 1.6 version or later (also integrated in the AuTom platform at http://ear.ict.ac.cn/) offers a complete implementation for fast alignment, in which fast fiducial marker tracking is available by the

  14. A fast fiducial marker tracking model for fully automatic alignment in electron tomography

    KAUST Repository

    Han, Renmin

    2017-10-20

    Automatic alignment, especially fiducial marker-based alignment, has become increasingly important due to the high demand of subtomogram averaging and the rapid development of large-field electron microscopy. Among the alignment steps, fiducial marker tracking is a crucial one that determines the quality of the final alignment. Yet, it is still a challenging problem to track the fiducial markers accurately and effectively in a fully automatic manner.In this paper, we propose a robust and efficient scheme for fiducial marker tracking. Firstly, we theoretically prove the upper bound of the transformation deviation of aligning the positions of fiducial markers on two micrographs by affine transformation. Secondly, we design an automatic algorithm based on the Gaussian mixture model to accelerate the procedure of fiducial marker tracking. Thirdly, we propose a divide-and-conquer strategy against lens distortions to ensure the reliability of our scheme. To our knowledge, this is the first attempt that theoretically relates the projection model with the tracking model. The real-world experimental results further support our theoretical bound and demonstrate the effectiveness of our algorithm. This work facilitates the fully automatic tracking for datasets with a massive number of fiducial markers.The C/C ++ source code that implements the fast fiducial marker tracking is available at https://github.com/icthrm/gmm-marker-tracking. Markerauto 1.6 version or later (also integrated in the AuTom platform at http://ear.ict.ac.cn/) offers a complete implementation for fast alignment, in which fast fiducial marker tracking is available by the

  15. 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

  16. Improving Reading Skills in Students with Dyslexia: The Efficacy of a Rhythmic Training

    Directory of Open Access Journals (Sweden)

    Alessandro eAntonietti

    2015-10-01

    Full Text Available The core deficit underlying developmental dyslexia (DD has been identified in difficulties in dynamic and rapidly changing auditory information processing, which contribute to the development of impaired phonological representations for words. It has been argued that enhancing basic musical rhythm perception skills in children with DD may have a positive effect on reading abilities because music and language share common mechanisms and thus transfer effects from the former to the latter are expected to occur. A computer-assisted training, called Rhythmic Reading Training (RRT, was designed in which reading exercises are combined with rhythm background. Fourteen junior high school students with DD took part to 9 biweekly individual sessions of 30 minutes in which RRT was implemented. Reading improvements after the intervention period were compared with ones of a matched control group of 14 students with DD who received no intervention. Results indicated that RRT had a positive effect on both reading speed and accuracy, and significant effects were found on short pseudo-words reading speed, long pseudo-words reading speed, high frequency long words reading accuracy, and text reading accuracy. No difference in rhythm perception between the intervention and control group were found. Findings suggest that rhythm facilitates the development of reading skill because of the temporal structure it imposes to word decoding.

  17. Fast discovery and visualization of conserved regions in DNA sequences using quasi-alignment.

    Science.gov (United States)

    Nagar, Anurag; Hahsler, Michael

    2013-01-01

    Next Generation Sequencing techniques are producing enormous amounts of biological sequence data and analysis becomes a major computational problem. Currently, most analysis, especially the identification of conserved regions, relies heavily on Multiple Sequence Alignment and its various heuristics such as progressive alignment, whose run time grows with the square of the number and the length of the aligned sequences and requires significant computational resources. In this work, we present a method to efficiently discover regions of high similarity across multiple sequences without performing expensive sequence alignment. The method is based on approximating edit distance between segments of sequences using p-mer frequency counts. Then, efficient high-throughput data stream clustering is used to group highly similar segments into so called quasi-alignments. Quasi-alignments have numerous applications such as identifying species and their taxonomic class from sequences, comparing sequences for similarities, and, as in this paper, discovering conserved regions across related sequences. In this paper, we show that quasi-alignments can be used to discover highly similar segments across multiple sequences from related or different genomes efficiently and accurately. Experiments on a large number of unaligned 16S rRNA sequences obtained from the Greengenes database show that the method is able to identify conserved regions which agree with known hypervariable regions in 16S rRNA. Furthermore, the experiments show that the proposed method scales well for large data sets with a run time that grows only linearly with the number and length of sequences, whereas for existing multiple sequence alignment heuristics the run time grows super-linearly. Quasi-alignment-based algorithms can detect highly similar regions and conserved areas across multiple sequences. Since the run time is linear and the sequences are converted into a compact clustering model, we are able to

  18. CMASA: an accurate algorithm for detecting local protein structural similarity and its application to enzyme catalytic site annotation

    Directory of Open Access Journals (Sweden)

    Li Gong-Hua

    2010-08-01

    Full Text Available Abstract Background The rapid development of structural genomics has resulted in many "unknown function" proteins being deposited in Protein Data Bank (PDB, thus, the functional prediction of these proteins has become a challenge for structural bioinformatics. Several sequence-based and structure-based methods have been developed to predict protein function, but these methods need to be improved further, such as, enhancing the accuracy, sensitivity, and the computational speed. Here, an accurate algorithm, the CMASA (Contact MAtrix based local Structural Alignment algorithm, has been developed to predict unknown functions of proteins based on the local protein structural similarity. This algorithm has been evaluated by building a test set including 164 enzyme families, and also been compared to other methods. Results The evaluation of CMASA shows that the CMASA is highly accurate (0.96, sensitive (0.86, and fast enough to be used in the large-scale functional annotation. Comparing to both sequence-based and global structure-based methods, not only the CMASA can find remote homologous proteins, but also can find the active site convergence. Comparing to other local structure comparison-based methods, the CMASA can obtain the better performance than both FFF (a method using geometry to predict protein function and SPASM (a local structure alignment method; and the CMASA is more sensitive than PINTS and is more accurate than JESS (both are local structure alignment methods. The CMASA was applied to annotate the enzyme catalytic sites of the non-redundant PDB, and at least 166 putative catalytic sites have been suggested, these sites can not be observed by the Catalytic Site Atlas (CSA. Conclusions The CMASA is an accurate algorithm for detecting local protein structural similarity, and it holds several advantages in predicting enzyme active sites. The CMASA can be used in large-scale enzyme active site annotation. The CMASA can be available by the

  19. Refinement procedure for the image alignment in high-resolution electron tomography

    International Nuclear Information System (INIS)

    Houben, L.; Bar Sadan, M.

    2011-01-01

    High-resolution electron tomography from a tilt series of transmission electron microscopy images requires an accurate image alignment procedure in order to maximise the resolution of the tomogram. This is the case in particular for ultra-high resolution where even very small misalignments between individual images can dramatically reduce the fidelity of the resultant reconstruction. A tomographic-reconstruction based and marker-free method is proposed, which uses an iterative optimisation of the tomogram resolution. The method utilises a search algorithm that maximises the contrast in tomogram sub-volumes. Unlike conventional cross-correlation analysis it provides the required correlation over a large tilt angle separation and guarantees a consistent alignment of images for the full range of object tilt angles. An assessment based on experimental reconstructions shows that the marker-free procedure is competitive to the reference of marker-based procedures at lower resolution and yields sub-pixel accuracy even for simulated high-resolution data. -- Highlights: → Alignment procedure for electron tomography based on iterative tomogram contrast optimisation. → Marker-free, independent of object, little user interaction. → Accuracy competitive with fiducial marker methods and suited for high-resolution tomography.

  20. Development of a High Precision Edge Alignment System for Touch-Panel Glass Substrates

    Directory of Open Access Journals (Sweden)

    Hau-Wei Lee

    2014-06-01

    Full Text Available There are two kinds of alignment systems, marked and unmarked. The glass substrate for touch panels is categorized as an unmarked work piece. Vision based glass substrate alignment (GSA relies on the edge of the glass. Traditional GSA systems compensate first for angular and then for linear error. This reduces alignment accuracy and increases alignment time and edge detection usually takes longer than 10 ms. This study proposes an effortless edge detection method. This method is very simple and can significantly reduce the time taken to detect the edge to about 6 ms using a 1.3 megapixel image. In this study, a floating center idea is used to control the glass substrate on a high precision coplanar XXY alignment stage. According to the method, users can set the rotation center anywhere as long as it is on the working (xy plane. Tolerance prognosis is also considered in this study to help the operator decide if the substrate is usable or should be rejected. The experimental results show alignment repeatability of the x, y, and θ axes to be 1 μm, 1 μm, and 5 arcsec, respectively.