WorldWideScience

Sample records for accurate short read

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

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

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

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

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

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

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

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

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

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

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

  14. Reading Abilities and Strategies: A Short Introduction

    Science.gov (United States)

    Liu, Feng

    2010-01-01

    This paper gives a short analysis of reading abilities and reading strategies. Much research has been done to investigate the nature of reading, though it's had to exactly define reading abilities and strategies. Different kinds of readings are discussed in this paper and distinctions are made between first language reading and second or foreign…

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

  16. Auditory short-term memory activation during score reading.

    Science.gov (United States)

    Simoens, Veerle L; Tervaniemi, Mari

    2013-01-01

    Performing music on the basis of reading a score requires reading ahead of what is being played in order to anticipate the necessary actions to produce the notes. Score reading thus not only involves the decoding of a visual score and the comparison to the auditory feedback, but also short-term storage of the musical information due to the delay of the auditory feedback during reading ahead. This study investigates the mechanisms of encoding of musical information in short-term memory during such a complicated procedure. There were three parts in this study. First, professional musicians participated in an electroencephalographic (EEG) experiment to study the slow wave potentials during a time interval of short-term memory storage in a situation that requires cross-modal translation and short-term storage of visual material to be compared with delayed auditory material, as it is the case in music score reading. This delayed visual-to-auditory matching task was compared with delayed visual-visual and auditory-auditory matching tasks in terms of EEG topography and voltage amplitudes. Second, an additional behavioural experiment was performed to determine which type of distractor would be the most interfering with the score reading-like task. Third, the self-reported strategies of the participants were also analyzed. All three parts of this study point towards the same conclusion according to which during music score reading, the musician most likely first translates the visual score into an auditory cue, probably starting around 700 or 1300 ms, ready for storage and delayed comparison with the auditory feedback.

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

  18. GAViT: Genome Assembly Visualization Tool for Short Read Data

    Energy Technology Data Exchange (ETDEWEB)

    Syed, Aijazuddin; Shapiro, Harris; Tu, Hank; Pangilinan, Jasmyn; Trong, Stephan

    2008-03-14

    It is a challenging job for genome analysts to accurately debug, troubleshoot, and validate genome assembly results. Genome analysts rely on visualization tools to help validate and troubleshoot assembly results, including such problems as mis-assemblies, low-quality regions, and repeats. Short read data adds further complexity and makes it extremely challenging for the visualization tools to scale and to view all needed assembly information. As a result, there is a need for a visualization tool that can scale to display assembly data from the new sequencing technologies. We present Genome Assembly Visualization Tool (GAViT), a highly scalable and interactive assembly visualization tool developed at the DOE Joint Genome Institute (JGI).

  19. Music memory following short-term practice and its relationship with the sight-reading abilities of professional pianists

    Directory of Open Access Journals (Sweden)

    Eriko eAiba

    2016-05-01

    Full Text Available This study investigated the relationship between the ability to sight-read and the ability to memorize a score using a behavioural experiment. By measuring the amount of memorization following short-term practice, we examined whether better sight-readers not only estimate forthcoming notes but also memorize musical structures and phrases with more practice.Eleven pianists performed the music first by sight-reading. After a 20-minute practice, the participants were asked to perform from memory without any advance notice. The number of mistakes was used as an index of performance.There were no correlations in the numbers of mistakes between sight-reading and memory trial performance. Some pianists memorized almost the entire score, while others hardly remembered it despite demonstrating almost completely accurate performance just before memory trial performance. However, judging from the participants’ responses to a questionnaire regarding their practice strategies, we found auditory memory was helpful for memorizing music following short-term practice.

  20. Music Memory Following Short-term Practice and Its Relationship with the Sight-reading Abilities of Professional Pianists.

    Science.gov (United States)

    Aiba, Eriko; Matsui, Toshie

    2016-01-01

    This study investigated the relationship between the ability to sight-read and the ability to memorize a score using a behavioral experiment. By measuring the amount of memorization following short-term practice, we examined whether better sight-readers not only estimate forthcoming notes but also memorize musical structures and phrases with more practice. Eleven pianists performed the music first by sight-reading. After a 20-minute practice, the participants were asked to perform from memory without any advance notice. The number of mistakes was used as an index of performance. There were no correlations in the numbers of mistakes between sight-reading and memory trial performance. Some pianists memorized almost the entire score, while others hardly remembered it despite demonstrating almost completely accurate performance just before memory trial performance. However, judging from the participants' responses to a questionnaire regarding their practice strategies, we found auditory memory was helpful for memorizing music following short-term practice.

  1. Repeat-aware modeling and correction of short read errors.

    Science.gov (United States)

    Yang, Xiao; Aluru, Srinivas; Dorman, Karin S

    2011-02-15

    High-throughput short read sequencing is revolutionizing genomics and systems biology research by enabling cost-effective deep coverage sequencing of genomes and transcriptomes. Error detection and correction are crucial to many short read sequencing applications including de novo genome sequencing, genome resequencing, and digital gene expression analysis. Short read error detection is typically carried out by counting the observed frequencies of kmers in reads and validating those with frequencies exceeding a threshold. In case of genomes with high repeat content, an erroneous kmer may be frequently observed if it has few nucleotide differences with valid kmers with multiple occurrences in the genome. Error detection and correction were mostly applied to genomes with low repeat content and this remains a challenging problem for genomes with high repeat content. We develop a statistical model and a computational method for error detection and correction in the presence of genomic repeats. We propose a method to infer genomic frequencies of kmers from their observed frequencies by analyzing the misread relationships among observed kmers. We also propose a method to estimate the threshold useful for validating kmers whose estimated genomic frequency exceeds the threshold. We demonstrate that superior error detection is achieved using these methods. Furthermore, we break away from the common assumption of uniformly distributed errors within a read, and provide a framework to model position-dependent error occurrence frequencies common to many short read platforms. Lastly, we achieve better error correction in genomes with high repeat content. The software is implemented in C++ and is freely available under GNU GPL3 license and Boost Software V1.0 license at "http://aluru-sun.ece.iastate.edu/doku.php?id = redeem". We introduce a statistical framework to model sequencing errors in next-generation reads, which led to promising results in detecting and correcting errors

  2. Optimizing de novo common wheat transcriptome assembly using short-read RNA-Seq data

    Directory of Open Access Journals (Sweden)

    Duan Jialei

    2012-08-01

    Full Text Available Abstract Background Rapid advances in next-generation sequencing methods have provided new opportunities for transcriptome sequencing (RNA-Seq. The unprecedented sequencing depth provided by RNA-Seq makes it a powerful and cost-efficient method for transcriptome study, and it has been widely used in model organisms and non-model organisms to identify and quantify RNA. For non-model organisms lacking well-defined genomes, de novo assembly is typically required for downstream RNA-Seq analyses, including SNP discovery and identification of genes differentially expressed by phenotypes. Although RNA-Seq has been successfully used to sequence many non-model organisms, the results of de novo assembly from short reads can still be improved by using recent bioinformatic developments. Results In this study, we used 212.6 million pair-end reads, which accounted for 16.2 Gb, to assemble the hexaploid wheat transcriptome. Two state-of-the-art assemblers, Trinity and Trans-ABySS, which use the single and multiple k-mer methods, respectively, were used, and the whole de novo assembly process was divided into the following four steps: pre-assembly, merging different samples, removal of redundancy and scaffolding. We documented every detail of these steps and how these steps influenced assembly performance to gain insight into transcriptome assembly from short reads. After optimization, the assembled transcripts were comparable to Sanger-derived ESTs in terms of both continuity and accuracy. We also provided considerable new wheat transcript data to the community. Conclusions It is feasible to assemble the hexaploid wheat transcriptome from short reads. Special attention should be paid to dealing with multiple samples to balance the spectrum of expression levels and redundancy. To obtain an accurate overview of RNA profiling, removal of redundancy may be crucial in de novo assembly.

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

  4. ISRNA: an integrative online toolkit for short reads from high-throughput sequencing data.

    Science.gov (United States)

    Luo, Guan-Zheng; Yang, Wei; Ma, Ying-Ke; Wang, Xiu-Jie

    2014-02-01

    Integrative Short Reads NAvigator (ISRNA) is an online toolkit for analyzing high-throughput small RNA sequencing data. Besides the high-speed genome mapping function, ISRNA provides statistics for genomic location, length distribution and nucleotide composition bias analysis of sequence reads. Number of reads mapped to known microRNAs and other classes of short non-coding RNAs, coverage of short reads on genes, expression abundance of sequence reads as well as some other analysis functions are also supported. The versatile search functions enable users to select sequence reads according to their sub-sequences, expression abundance, genomic location, relationship to genes, etc. A specialized genome browser is integrated to visualize the genomic distribution of short reads. ISRNA also supports management and comparison among multiple datasets. ISRNA is implemented in Java/C++/Perl/MySQL and can be freely accessed at http://omicslab.genetics.ac.cn/ISRNA/.

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

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

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

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

  9. Short Vowels Versus Word Familiarity in the Reading Comprehension of Arab Readers: A Revisited Issue

    Directory of Open Access Journals (Sweden)

    Abdullah M. SERAYE

    2016-03-01

    Full Text Available Arab readers, both beginning and advanced, are encouraged to read and accustomed to unvowelized and undiacriticized texts. Previous literature claimed that the presence of short vowels in the text would facilitate the reading comprehension of both beginning and advanced Arab readers. However, with a claimed strict controlling procedure, different results emerged, revealing that the only variable that affected the reading process of Arab adult skilled readers was word frequency, and its effect was limited to the time load of the reading process; this result raised the question of whether the neutral role of short vowels in the text reading process of experienced Arab readers would be maintained for less experienced readers, as represented by fourth graders, or whether word frequency would be the only variable that plays a role in their reading process. In experiment, 1,141 fourth-grade students were randomly assigned to 5 reading conditions: plain, only shaddah, short vowels plus shaddah, only short vowels, and finally the wrong short vowels plus shaddah. In experiment 2, 38 participants from the same population were assigned to a fully vowelized and diacriticized reading condition. Each participant was asked to read two texts, of high and low frequency words and then given recall and multiple-choice tests. In general, the multivariate analysis showed that the only manipulated variable that was found to affect their reading process in terms of reading time load and, to some degree, reading comprehension was word frequency, although its effect was marginal. Accordingly, pedagogical recommendations and future research were proposed.

  10. Short vowels versus word familiarity in the reading comprehension of arab readers: A revisited issue

    Directory of Open Access Journals (Sweden)

    Abdullah M. Seraye

    2016-03-01

    Full Text Available Arab readers, both beginning and advanced, are encouraged to read and accustomed to unvowelized and undiacriticized texts. Previous literature claimed that the presence of short vowels in the text would facilitate the reading comprehension of both beginning and advanced Arab readers. However, with a claimed strict controlling procedure, different results emerged, revealing that the only variable that affected the reading process of Arab adult skilled readers was word frequency, and its effect was limited to the time load of the reading process; this result raised the question of whether the neutral role of short vowels in the text reading process of experienced Arab readers would be maintained for less experienced readers, as represented by fourth graders, or whether word frequency would be the only variable that plays a role in their reading process. In experiment, 1,141 fourth-grade students were randomly assigned to 5 reading conditions: plain, only shaddah, short vowels plus shaddah, only short vowels, and finally the wrong short vowels plus shaddah. In experiment 2, 38 participants from the same population were assigned to a fully vowelized and diacriticized reading condition. Each participant was asked to read two texts, of high and low frequency words and then given recall and multiple-choice tests. In general, the multivariate analysis showed that the only manipulated variable that was found to affect their reading process in terms of reading time load and, to some degree, reading comprehension was word frequency, although its effect was marginal. Accordingly, pedagogical recommendations and future research were proposed.

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

  12. SeqEntropy: genome-wide assessment of repeats for short read sequencing.

    Directory of Open Access Journals (Sweden)

    Hsueh-Ting Chu

    Full Text Available BACKGROUND: Recent studies on genome assembly from short-read sequencing data reported the limitation of this technology to reconstruct the entire genome even at very high depth coverage. We investigated the limitation from the perspective of information theory to evaluate the effect of repeats on short-read genome assembly using idealized (error-free reads at different lengths. METHODOLOGY/PRINCIPAL FINDINGS: We define a metric H(k to be the entropy of sequencing reads at a read length k and use the relative loss of entropy ΔH(k to measure the impact of repeats for the reconstruction of whole-genome from sequences of length k. In our experiments, we found that entropy loss correlates well with de-novo assembly coverage of a genome, and a score of ΔH(k>1% indicates a severe loss in genome reconstruction fidelity. The minimal read lengths to achieve ΔH(k<1% are different for various organisms and are independent of the genome size. For example, in order to meet the threshold of ΔH(k<1%, a read length of 60 bp is needed for the sequencing of human genome (3.2 10(9 bp and 320 bp for the sequencing of fruit fly (1.8×10(8 bp. We also calculated the ΔH(k scores for 2725 prokaryotic chromosomes and plasmids at several read lengths. Our results indicate that the levels of repeats in different genomes are diverse and the entropy of sequencing reads provides a measurement for the repeat structures. CONCLUSIONS/SIGNIFICANCE: The proposed entropy-based measurement, which can be calculated in seconds to minutes in most cases, provides a rapid quantitative evaluation on the limitation of idealized short-read genome sequencing. Moreover, the calculation can be parallelized to scale up to large euakryotic genomes. This approach may be useful to tune the sequencing parameters to achieve better genome assemblies when a closely related genome is already available.

  13. Meraculous: De Novo Genome Assembly with Short Paired-End Reads

    Energy Technology Data Exchange (ETDEWEB)

    Chapman, Jarrod A.; Ho, Isaac; Sunkara, Sirisha; Luo, Shujun; Schroth, Gary P.; Rokhsar, Daniel S.; Salzberg, Steven L.

    2011-08-18

    We describe a new algorithm, meraculous, for whole genome assembly of deep paired-end short reads, and apply it to the assembly of a dataset of paired 75-bp Illumina reads derived from the 15.4 megabase genome of the haploid yeast Pichia stipitis. More than 95% of the genome is recovered, with no errors; half the assembled sequence is in contigs longer than 101 kilobases and in scaffolds longer than 269 kilobases. Incorporating fosmid ends recovers entire chromosomes. Meraculous relies on an efficient and conservative traversal of the subgraph of the k-mer (deBruijn) graph of oligonucleotides with unique high quality extensions in the dataset, avoiding an explicit error correction step as used in other short-read assemblers. A novel memory-efficient hashing scheme is introduced. The resulting contigs are ordered and oriented using paired reads separated by ~280 bp or ~3.2 kbp, and many gaps between contigs can be closed using paired-end placements. Practical issues with the dataset are described, and prospects for assembling larger genomes are discussed.

  14. DistMap: a toolkit for distributed short read mapping on a Hadoop cluster.

    Directory of Open Access Journals (Sweden)

    Ram Vinay Pandey

    Full Text Available With the rapid and steady increase of next generation sequencing data output, the mapping of short reads has become a major data analysis bottleneck. On a single computer, it can take several days to map the vast quantity of reads produced from a single Illumina HiSeq lane. In an attempt to ameliorate this bottleneck we present a new tool, DistMap - a modular, scalable and integrated workflow to map reads in the Hadoop distributed computing framework. DistMap is easy to use, currently supports nine different short read mapping tools and can be run on all Unix-based operating systems. It accepts reads in FASTQ format as input and provides mapped reads in a SAM/BAM format. DistMap supports both paired-end and single-end reads thereby allowing the mapping of read data produced by different sequencing platforms. DistMap is available from http://code.google.com/p/distmap/

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

  16. Identifying wrong assemblies in de novo short read primary ...

    Indian Academy of Sciences (India)

    2016-08-05

    Aug 5, 2016 ... Most of these assemblies are done using some de novo short read assemblers and other related approaches. .... benchmarking projects like Assemblathon 1, Assemblathon ... from a large insert library (at least 1000 bases).

  17. Working memory, short-term memory and reading proficiency in school-age children with cochlear implants.

    Science.gov (United States)

    Bharadwaj, Sneha V; Maricle, Denise; Green, Laura; Allman, Tamby

    2015-10-01

    The objective of the study was to examine short-term memory and working memory through both visual and auditory tasks in school-age children with cochlear implants. The relationship between the performance on these cognitive skills and reading as well as language outcomes were examined in these children. Ten children between the ages of 7 and 11 years with early-onset bilateral severe-profound hearing loss participated in the study. Auditory and visual short-term memory, auditory and visual working memory subtests and verbal knowledge measures were assessed using the Woodcock Johnson III Tests of Cognitive Abilities, the Wechsler Intelligence Scale for Children-IV Integrated and the Kaufman Assessment Battery for Children II. Reading outcomes were assessed using the Woodcock Reading Mastery Test III. Performance on visual short-term memory and visual working memory measures in children with cochlear implants was within the average range when compared to the normative mean. However, auditory short-term memory and auditory working memory measures were below average when compared to the normative mean. Performance was also below average on all verbal knowledge measures. Regarding reading outcomes, children with cochlear implants scored below average for listening and passage comprehension tasks and these measures were positively correlated to visual short-term memory, visual working memory and auditory short-term memory. Performance on auditory working memory subtests was not related to reading or language outcomes. The children with cochlear implants in this study demonstrated better performance in visual (spatial) working memory and short-term memory skills than in auditory working memory and auditory short-term memory skills. Significant positive relationships were found between visual working memory and reading outcomes. The results of the study provide support for the idea that WM capacity is modality specific in children with hearing loss. Based on these

  18. Short-read reading-frame predictors are not created equal: sequence error causes loss of signal

    Directory of Open Access Journals (Sweden)

    Trimble William L

    2012-07-01

    Full Text Available Abstract Background Gene prediction algorithms (or gene callers are an essential tool for analyzing shotgun nucleic acid sequence data. Gene prediction is a ubiquitous step in sequence analysis pipelines; it reduces the volume of data by identifying the most likely reading frame for a fragment, permitting the out-of-frame translations to be ignored. In this study we evaluate five widely used ab initio gene-calling algorithms—FragGeneScan, MetaGeneAnnotator, MetaGeneMark, Orphelia, and Prodigal—for accuracy on short (75–1000 bp fragments containing sequence error from previously published artificial data and “real” metagenomic datasets. Results While gene prediction tools have similar accuracies predicting genes on error-free fragments, in the presence of sequencing errors considerable differences between tools become evident. For error-containing short reads, FragGeneScan finds more prokaryotic coding regions than does MetaGeneAnnotator, MetaGeneMark, Orphelia, or Prodigal. This improved detection of genes in error-containing fragments, however, comes at the cost of much lower (50% specificity and overprediction of genes in noncoding regions. Conclusions Ab initio gene callers offer a significant reduction in the computational burden of annotating individual nucleic acid reads and are used in many metagenomic annotation systems. For predicting reading frames on raw reads, we find the hidden Markov model approach in FragGeneScan is more sensitive than other gene prediction tools, while Prodigal, MGA, and MGM are better suited for higher-quality sequences such as assembled contigs.

  19. L2 Reading Ability: Further Insight into the Short-Circuit Hypothesis.

    Science.gov (United States)

    Taillefer, Gail F.

    1996-01-01

    Discusses the notion of a language proficiency threshold that short circuits the transfer of reading ability from the native language (L1) to a second language (L2). This study, in which cognitive complexity of tasks and students' L2 proficiency levels vary, focuses on university students in France reading preprofessional English texts. (39…

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

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

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

  3. SRComp: short read sequence compression using burstsort and Elias omega coding.

    Directory of Open Access Journals (Sweden)

    Jeremy John Selva

    Full Text Available Next-generation sequencing (NGS technologies permit the rapid production of vast amounts of data at low cost. Economical data storage and transmission hence becomes an increasingly important challenge for NGS experiments. In this paper, we introduce a new non-reference based read sequence compression tool called SRComp. It works by first employing a fast string-sorting algorithm called burstsort to sort read sequences in lexicographical order and then Elias omega-based integer coding to encode the sorted read sequences. SRComp has been benchmarked on four large NGS datasets, where experimental results show that it can run 5-35 times faster than current state-of-the-art read sequence compression tools such as BEETL and SCALCE, while retaining comparable compression efficiency for large collections of short read sequences. SRComp is a read sequence compression tool that is particularly valuable in certain applications where compression time is of major concern.

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

  5. The contribution of short-term memory capacity to reading ability in adolescents with cochlear implants.

    Science.gov (United States)

    Edwards, Lindsey; Aitkenhead, Lynne; Langdon, Dawn

    2016-11-01

    This study aimed to establish the relationship between short-term memory capacity and reading skills in adolescents with cochlear implants. A between-groups design compared a group of young people with cochlear implants with a group of hearing peers on measures of reading, and auditory and visual short-term memory capacity. The groups were matched for non-verbal IQ and age. The adolescents with cochlear implants were recruited from the Cochlear Implant Programme at a specialist children's hospital. The hearing participants were recruited from the same schools as those attended by the implanted adolescents. Participants were 18 cochlear implant users and 14 hearing controls, aged between 12 and 18 years. All used English as their main language and had no significant learning disability or neuro-developmental disorder. Short-term memory capacity was assessed in the auditory modality using Forward and Reverse Digit Span from the WISC IV UK, and visually using Forward and Reverse Memory from the Leiter-R. Individual word reading, reading comprehension and pseudoword decoding were assessed using the WIAT II UK. A series of ANOVAs revealed that the adolescents with cochlear implants had significantly poorer auditory short-term memory capacity and reading skills (on all measures) compared with their hearing peers. However, when Forward Digit Span was entered into the analyses as a covariate, none of the differences remained statistically significant. Deficits in immediate auditory memory persist into adolescence in deaf children with cochlear implants. Short-term auditory memory capacity is an important neurocognitive process in the development of reading skills after cochlear implantation in childhood that remains evident in later adolescence. Copyright © 2016 Elsevier Ireland Ltd. All rights reserved.

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

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

  8. I RAN Fast and I Remembered What I Read: The Relationship between Reading, Rapid Automatic Naming, and Auditory and Visual Short-Term Memory

    Directory of Open Access Journals (Sweden)

    Sheila G. Crewther

    2011-05-01

    Full Text Available Although rapid automatic naming (RAN speed and short-term auditory memory are widely recognised as good predictors of reading ability in most age groups, the predictive value of short-term memory for visually presented digits for reading and RAN in young typically developing learner readers (mean age 91.5 months has seldom been investigated. We found that visual digit span is a better predictor of reading ability than auditory digit span in learner readers. A significant correlation has also been found between RAN speed and visual, but not auditory digit span. These results suggests that RAN speed may be a good predictor of a child's future reading ability and eventual fluency because like visual digit span, it is a measure of rate of access to memory for the visual icons and their semantic name and meaning. The results also suggest that auditory memory is not an important factor in young children learning to read.

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

  10. CRISPR Detection From Short Reads Using Partial Overlap Graphs.

    Science.gov (United States)

    Ben-Bassat, Ilan; Chor, Benny

    2016-06-01

    Clustered regularly interspaced short palindromic repeats (CRISPR) are structured regions in bacterial and archaeal genomes, which are part of an adaptive immune system against phages. CRISPRs are important for many microbial studies and are playing an essential role in current gene editing techniques. As such, they attract substantial research interest. The exponential growth in the amount of bacterial sequence data in recent years enables the exploration of CRISPR loci in more and more species. Most of the automated tools that detect CRISPR loci rely on fully assembled genomes. However, many assemblers do not handle repetitive regions successfully. The first tool to work directly on raw sequence data is Crass, which requires reads that are long enough to contain two copies of the same repeat. We present a method to identify CRISPR repeats from raw sequence data of short reads. The algorithm is based on an observation differentiating CRISPR repeats from other types of repeats, and it involves a series of partial constructions of the overlap graph. This enables us to avoid many of the difficulties that assemblers face, as we merely aim to identify the repeats that belong to CRISPR loci. A preliminary implementation of the algorithm shows good results and detects CRISPR repeats in cases where other existing tools fail to do so.

  11. Short Vowels versus Word Familiarity in the Reading Comprehension of Arab Readers: A Revisited Issue

    Science.gov (United States)

    Seraye, Abdullah M.

    2016-01-01

    Arab readers, both beginning and advanced, are encouraged to read and accustomed to unvowelized and undiacriticized texts. Previous literature claimed that the presence of short vowels in the text would facilitate the reading comprehension of both beginning and advanced Arab readers. However, with a claimed strict controlling procedure, different…

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

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

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

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

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

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

  18. Orthographic Structure and Reading Experience Affect the Transfer from Iconic to Short Term Memory

    Science.gov (United States)

    Lefton, Lester A.; Spragins, Anne B.

    1974-01-01

    The basic hypothesis of these experiments was that the processing strategy for the transfer of alphabetic material from iconic storage to short-term memory involves a sequential left-to-right factor that develops with increases in experience with reading. (Author)

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

  20. A filtering method to generate high quality short reads using illumina paired-end technology.

    Science.gov (United States)

    Eren, A Murat; Vineis, Joseph H; Morrison, Hilary G; Sogin, Mitchell L

    2013-01-01

    Consensus between independent reads improves the accuracy of genome and transcriptome analyses, however lack of consensus between very similar sequences in metagenomic studies can and often does represent natural variation of biological significance. The common use of machine-assigned quality scores on next generation platforms does not necessarily correlate with accuracy. Here, we describe using the overlap of paired-end, short sequence reads to identify error-prone reads in marker gene analyses and their contribution to spurious OTUs following clustering analysis using QIIME. Our approach can also reduce error in shotgun sequencing data generated from libraries with small, tightly constrained insert sizes. The open-source implementation of this algorithm in Python programming language with user instructions can be obtained from https://github.com/meren/illumina-utils.

  1. The Contribution of Short-Term Memory for Serial Order to Early Reading Acquisition: Evidence from a Longitudinal Study

    Science.gov (United States)

    Perez, Trecy Martinez; Majerus, Steve; Poncelet, Martine

    2012-01-01

    Early reading acquisition skills have been linked to verbal short-term memory (STM) capacity. However, the nature of this relationship remains controversial because verbal STM, like reading acquisition, depends on the complexity of underlying phonological processing skills. This longitudinal study addressed the relation between STM and reading…

  2. A filtering method to generate high quality short reads using illumina paired-end technology.

    Directory of Open Access Journals (Sweden)

    A Murat Eren

    Full Text Available Consensus between independent reads improves the accuracy of genome and transcriptome analyses, however lack of consensus between very similar sequences in metagenomic studies can and often does represent natural variation of biological significance. The common use of machine-assigned quality scores on next generation platforms does not necessarily correlate with accuracy. Here, we describe using the overlap of paired-end, short sequence reads to identify error-prone reads in marker gene analyses and their contribution to spurious OTUs following clustering analysis using QIIME. Our approach can also reduce error in shotgun sequencing data generated from libraries with small, tightly constrained insert sizes. The open-source implementation of this algorithm in Python programming language with user instructions can be obtained from https://github.com/meren/illumina-utils.

  3. Psychomotor Ability and Short-term Memory, and Reading and Mathematics Achievement in Children.

    Science.gov (United States)

    Murrihy, Cherée; Bailey, Maria; Roodenburg, John

    2017-08-01

    The aim of our study was to examine whether the findings from previous research, indicating the role of short-term memory as a mediator of the relationship between motor coordination and academic achievement in adolescents, is also evident in a younger child population. The study utilized a quantative cross-sectional design involving 133 children aged 8-12. The McCarron Assessment of Neuromuscular Development (MAND) provided four indicators of psychomotor ability (Finger Nose, Walking, Balancing, and Jumping). The Woodcock-Johnson Cognitive battery and the Automated Working Memory Assessment (AWMA) provided two measures of short-term memory (Numbers Reversed and Digit Recall) and the WJIII Achievement battery provided two measures of reading achievement (Letter-word Identification and Passage Comprehension) and two measures of mathematics achievement (Applied Problems and Calculation). Structural equation modeling was used, controlling for age, processing speed, crystallized, and fluid intelligence where appropriate. The results found support for the hypothesis that short-term memory fully mediates the relationship between psychomotor ability and reading and mathematics achievement. These findings indicate the significant affect of psychomotor ability on learning outcomes and consequently the need to assess these in considering learning difficulties, and as such these findings also advance understanding of developmental neural mechanisms underpinning the relationships. © The Author 2017. Published by Oxford University Press. All rights reserved. For permissions, please e-mail: journals.permissions@oup.com.

  4. Assembly of highly repetitive genomes using short reads: the genome of discrete typing unit III Trypanosoma cruzi strain 231.

    Science.gov (United States)

    Baptista, Rodrigo P; Reis-Cunha, Joao Luis; DeBarry, Jeremy D; Chiari, Egler; Kissinger, Jessica C; Bartholomeu, Daniella C; Macedo, Andrea M

    2018-02-14

    Next-generation sequencing (NGS) methods are low-cost high-throughput technologies that produce thousands to millions of sequence reads. Despite the high number of raw sequence reads, their short length, relative to Sanger, PacBio or Nanopore reads, complicates the assembly of genomic repeats. Many genome tools are available, but the assembly of highly repetitive genome sequences using only NGS short reads remains challenging. Genome assembly of organisms responsible for important neglected diseases such as Trypanosoma cruzi, the aetiological agent of Chagas disease, is known to be challenging because of their repetitive nature. Only three of six recognized discrete typing units (DTUs) of the parasite have their draft genomes published and therefore genome evolution analyses in the taxon are limited. In this study, we developed a computational workflow to assemble highly repetitive genomes via a combination of de novo and reference-based assembly strategies to better overcome the intrinsic limitations of each, based on Illumina reads. The highly repetitive genome of the human-infecting parasite T. cruzi 231 strain was used as a test subject. The combined-assembly approach shown in this study benefits from the reference-based assembly ability to resolve highly repetitive sequences and from the de novo capacity to assemble genome-specific regions, improving the quality of the assembly. The acceptable confidence obtained by analyzing our results showed that our combined approach is an attractive option to assemble highly repetitive genomes with NGS short reads. Phylogenomic analysis including the 231 strain, the first representative of DTU III whose genome was sequenced, was also performed and provides new insights into T. cruzi genome evolution.

  5. Genomic dark matter: the reliability of short read mapping illustrated by the genome mappability score.

    Science.gov (United States)

    Lee, Hayan; Schatz, Michael C

    2012-08-15

    Genome resequencing and short read mapping are two of the primary tools of genomics and are used for many important applications. The current state-of-the-art in mapping uses the quality values and mapping quality scores to evaluate the reliability of the mapping. These attributes, however, are assigned to individual reads and do not directly measure the problematic repeats across the genome. Here, we present the Genome Mappability Score (GMS) as a novel measure of the complexity of resequencing a genome. The GMS is a weighted probability that any read could be unambiguously mapped to a given position and thus measures the overall composition of the genome itself. We have developed the Genome Mappability Analyzer to compute the GMS of every position in a genome. It leverages the parallelism of cloud computing to analyze large genomes, and enabled us to identify the 5-14% of the human, mouse, fly and yeast genomes that are difficult to analyze with short reads. We examined the accuracy of the widely used BWA/SAMtools polymorphism discovery pipeline in the context of the GMS, and found discovery errors are dominated by false negatives, especially in regions with poor GMS. These errors are fundamental to the mapping process and cannot be overcome by increasing coverage. As such, the GMS should be considered in every resequencing project to pinpoint the 'dark matter' of the genome, including of known clinically relevant variations in these regions. The source code and profiles of several model organisms are available at http://gma-bio.sourceforge.net

  6. Music Memory Following Short-term Practice and Its Relationship with the Sight-reading Abilities of Professional Pianists

    OpenAIRE

    Aiba, Eriko; Matsui, Toshie

    2016-01-01

    This study investigated the relationship between the ability to sight-read and the ability to memorize a score using a behavioral experiment. By measuring the amount of memorization following short-term practice, we examined whether better sight-readers not only estimate forthcoming notes but also memorize musical structures and phrases with more practice. Eleven pianists performed the music first by sight-reading. After a 20-minute practice, the participants were asked to perform from memory...

  7. Rapid hybrid de novo assembly of a microbial genome using only short reads: Corynebacterium pseudotuberculosis I19 as a case study.

    Science.gov (United States)

    Cerdeira, Louise Teixeira; Carneiro, Adriana Ribeiro; Ramos, Rommel Thiago Jucá; de Almeida, Sintia Silva; D'Afonseca, Vivian; Schneider, Maria Paula Cruz; Baumbach, Jan; Tauch, Andreas; McCulloch, John Anthony; Azevedo, Vasco Ariston Carvalho; Silva, Artur

    2011-08-01

    Due to the advent of the so-called Next-Generation Sequencing (NGS) technologies the amount of monetary and temporal resources for whole-genome sequencing has been reduced by several orders of magnitude. Sequence reads can be assembled either by anchoring them directly onto an available reference genome (classical reference assembly), or can be concatenated by overlap (de novo assembly). The latter strategy is preferable because it tends to maintain the architecture of the genome sequence the however, depending on the NGS platform used, the shortness of read lengths cause tremendous problems the in the subsequent genome assembly phase, impeding closing of the entire genome sequence. To address the problem, we developed a multi-pronged hybrid de novo strategy combining De Bruijn graph and Overlap-Layout-Consensus methods, which was used to assemble from short reads the entire genome of Corynebacterium pseudotuberculosis strain I19, a bacterium with immense importance in veterinary medicine that causes Caseous Lymphadenitis in ruminants, principally ovines and caprines. Briefly, contigs were assembled de novo from the short reads and were only oriented using a reference genome by anchoring. Remaining gaps were closed using iterative anchoring of short reads by craning to gap flanks. Finally, we compare the genome sequence assembled using our hybrid strategy to a classical reference assembly using the same data as input and show that with the availability of a reference genome, it pays off to use the hybrid de novo strategy, rather than a classical reference assembly, because more genome sequences are preserved using the former. Copyright © 2011 Elsevier B.V. All rights reserved.

  8. The Relative Predictive Contribution and Causal Role of Phoneme Awareness, Rhyme Awareness, and Verbal Short-Term Memory in Reading Skills: A Review

    Science.gov (United States)

    Melby-Lervag, Monica

    2012-01-01

    The acknowledgement that educational achievement is highly dependent on successful reading development has led to extensive research on its underlying factors. A strong argument has been made for a causal relationship between reading and phoneme awareness; similarly, causal relations have been suggested for reading with short-term memory and rhyme…

  9. Unpacking Direct and Indirect Relationships of Short-Term Memory to Word Reading: Evidence From Korean-Speaking Children.

    Science.gov (United States)

    Kim, Young-Suk Grace; Cho, Jeung-Ryeul; Park, Soon-Gil

    2017-08-01

    We examined the relations of short-term memory (STM), metalinguistic awareness (phonological, morphological, and orthographic awareness), and rapid automatized naming (RAN) to word reading in Korean, a language with a relatively transparent orthography. STM, metalinguistic awareness, and RAN have been shown to be important to word reading, but the nature of the relations of STM, metalinguistic awareness, and RAN to word reading has rarely been investigated. Two alternative models were fitted. In the indirect relation model, STM was hypothesized to be indirectly related to word reading via metalinguistic awareness and RAN. In the direct and indirect relations model, STM was hypothesized to be directly and indirectly related to word reading. Results from 207 beginning readers in South Korea showed that STM was directly related to word reading as well as indirectly via metalinguistic awareness and RAN. Although the direct effect of STM was relatively small (.16), the total effect incorporating the indirect effect was substantial (.42). These results suggest that STM is an important, foundational cognitive capacity that underpins metalinguistic awareness and RAN as well as word reading, and further indicate the importance of considering both direct and indirect effects of language and cognitive skills on word reading.

  10. High-Specificity Targeted Functional Profiling in Microbial Communities with ShortBRED.

    Directory of Open Access Journals (Sweden)

    James Kaminski

    2015-12-01

    Full Text Available Profiling microbial community function from metagenomic sequencing data remains a computationally challenging problem. Mapping millions of DNA reads from such samples to reference protein databases requires long run-times, and short read lengths can result in spurious hits to unrelated proteins (loss of specificity. We developed ShortBRED (Short, Better Representative Extract Dataset to address these challenges, facilitating fast, accurate functional profiling of metagenomic samples. ShortBRED consists of two components: (i a method that reduces reference proteins of interest to short, highly representative amino acid sequences ("markers" and (ii a search step that maps reads to these markers to quantify the relative abundance of their associated proteins. After evaluating ShortBRED on synthetic data, we applied it to profile antibiotic resistance protein families in the gut microbiomes of individuals from the United States, China, Malawi, and Venezuela. Our results support antibiotic resistance as a core function in the human gut microbiome, with tetracycline-resistant ribosomal protection proteins and Class A beta-lactamases being the most widely distributed resistance mechanisms worldwide. ShortBRED markers are applicable to other homology-based search tasks, which we demonstrate here by identifying phylogenetic signatures of antibiotic resistance across more than 3,000 microbial isolate genomes. ShortBRED can be applied to profile a wide variety of protein families of interest; the software, source code, and documentation are available for download at http://huttenhower.sph.harvard.edu/shortbred.

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

  12. The contribution of short-term memory for serial order to early reading acquisition: evidence from a longitudinal study.

    Science.gov (United States)

    Martinez Perez, Trecy; Majerus, Steve; Poncelet, Martine

    2012-04-01

    Early reading acquisition skills have been linked to verbal short-term memory (STM) capacity. However, the nature of this relationship remains controversial because verbal STM, like reading acquisition, depends on the complexity of underlying phonological processing skills. This longitudinal study addressed the relation between STM and reading decoding acquisition by distinguishing between STM for item information and STM for order information based on recent studies showing that STM for item information, but not STM for order information, recruits underlying phonological representations. If there is a specific link between STM and reading decoding acquisition, STM for order information should be an independent predictor of reading decoding acquisition. Tasks maximizing STM for serial order or item information, measures of phonological abilities, and reading tests were administered to children followed from kindergarten through first grade. We observed that order STM capacity, but not item STM capacity, predicted independent variance in reading decoding abilities 1 year later. These results highlight the specific role of STM for order in reading decoding acquisition and argue for a causal role of order STM capacity in reading acquisition. Mechanisms relating STM for order information and reading acquisition are discussed. Copyright © 2011 Elsevier Inc. All rights reserved.

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

  14. Characterizing novel endogenous retroviruses from genetic variation inferred from short sequence reads

    DEFF Research Database (Denmark)

    Mourier, Tobias; Mollerup, Sarah; Vinner, Lasse

    2015-01-01

    From Illumina sequencing of DNA from brain and liver tissue from the lion, Panthera leo, and tumor samples from the pike-perch, Sander lucioperca, we obtained two assembled sequence contigs with similarity to known retroviruses. Phylogenetic analyses suggest that the pike-perch retrovirus belongs...... to the epsilonretroviruses, and the lion retrovirus to the gammaretroviruses. To determine if these novel retroviral sequences originate from an endogenous retrovirus or from a recently integrated exogenous retrovirus, we assessed the genetic diversity of the parental sequences from which the short Illumina reads...

  15. Reading in developmental prosopagnosia

    DEFF Research Database (Denmark)

    Starrfelt, Randi; Klargaard, Solja K; Petersen, Anders

    2018-01-01

    exposure durations (targeting the word superiority effect), and d) text reading. RESULTS: Participants with developmental prosopagnosia performed strikingly similar to controls across the four reading tasks. Formal analysis revealed a significant dissociation between word and face recognition......, that is, impaired reading in developmental prosopagnosia. METHOD: We tested 10 adults with developmental prosopagnosia and 20 matched controls. All participants completed the Cambridge Face Memory Test, the Cambridge Face Perception test and a Face recognition questionnaire used to quantify everyday face...... recognition experience. Reading was measured in four experimental tasks, testing different levels of letter, word, and text reading: (a) single word reading with words of varying length,(b) vocal response times in single letter and short word naming, (c) recognition of single letters and short words at brief...

  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. Fast and Accurate Icepak-PSpice Co-Simulation of IGBTs under Short-Circuit with an Advanced PSpice Model

    DEFF Research Database (Denmark)

    Wu, Rui; Iannuzzo, Francesco; Wang, Huai

    2014-01-01

    A basic problem in the IGBT short-circuit failure mechanism study is to obtain realistic temperature distribution inside the chip, which demands accurate electrical simulation to obtain power loss distribution as well as detailed IGBT geometry and material information. This paper describes an unp...

  18. Using Supplementary Readings (Short Stories) in Increasing the Conceptual Fluency, the Case of Idioms in English

    Science.gov (United States)

    Mokhtari, Elahe; Talebinezhad, Mohammed Reza

    2014-01-01

    The aim of this research was to probed whether using supplementary readings (short stories containing idioms) increase conceptual fluency of L2 learners. In line with the goal of the study, first, the researcher selected a sample of 30 female lower-intermediate L2 learners from Sadr Private Language Centre in Isfahan. She selected them based on…

  19. The role of morphology and short vowelization in reading Arabic among normal and dyslexic readers in grades 3, 6, 9, and 12.

    Science.gov (United States)

    Abu-Rabia, Salim

    2007-03-01

    This study was an investigation of several Arabic reading measures among dyslexics and normal Arabic readers across different ages (grades 3, 6, 9, and 12): the role of morphology, short vowelization (phonological and syntactic skills), spelling, reading isolated words, and reading comprehension. The results of the one-way ANOVAs indicated clear differences between the dyslexic readers and the normal readers on all reading measures. However, the stepwise regression analysis revealed consistent orthographic results: morphology (identification and/or production) and spelling were generally the most powerful predictors of both reading accuracy and reading comprehension among dyslexic and normal readers across these different age groups. The results are discussed in terms of the characteristics of the Arabic orthography and the heavy reliance of readers at all levels and ages on orthographic factors in reading.

  20. The Short Circuit Hypothesis of ESL Reading--Or when Language Competence Interferes with Reading Performance.

    Science.gov (United States)

    Clarke, Mark A.

    1980-01-01

    Examines a sampling of current ESL reading instruction practices, addressing the concern that the lack of a generally accepted theory of L2 reading constitutes a major obstacle to teaching and testing ESL reading skills. Summarizes the results of two studies and discusses their implications for ESL teachers. (MES)

  1. The Danish version of the Radner Reading Chart

    DEFF Research Database (Denmark)

    Munch, Inger Christine; Jørgensen, Astrid Helene Ravn; Radner, Wolfgang

    2016-01-01

    , variance and number of errors per short text. Results The students read the short texts faster than the blue-collar workers (184 ± 21.4 words per minute (wpm) versus 163 ± 26.3 wpm, p ...Purpose To develop 28 short texts to be used as sentence optotypes in a Danish version of the Radner Reading Chart for the measurement of reading acuity and speed. Method Forty-six short texts of comparable lexical and grammatical difficulty were constructed. The short texts were tested together...... with two longer reference texts in 100 persons with visual acuity 6/6, of which 50 were university students (age: 24.7 ± 3.1 years, 36% males) and 50 were blue-collar workers (37.2 ± 13.4 years, 54% males). Study parameters were mean reading speed and error rate per participant, and mean reading time...

  2. Functional and Structural Neuroplasticity Induced by Short-Term Tactile Training Based on Braille Reading.

    Science.gov (United States)

    Debowska, Weronika; Wolak, Tomasz; Nowicka, Anna; Kozak, Anna; Szwed, Marcin; Kossut, Malgorzata

    2016-01-01

    Neuroplastic changes induced by sensory learning have been recognized within the cortices of specific modalities as well as within higher ordered multimodal areas. The interplay between these areas is not fully understood, particularly in the case of somatosensory learning. Here we examined functional and structural changes induced by short-term tactile training based of Braille reading, a task that requires both significant tactile expertise and mapping of tactile input onto multimodal representations. Subjects with normal vision were trained for 3 weeks to read Braille exclusively by touch and scanned before and after training, while performing a same-different discrimination task on Braille characters and meaningless characters. Functional and diffusion-weighted magnetic resonance imaging sequences were used to assess resulting changes. The strongest training-induced effect was found in the primary somatosensory cortex (SI), where we observed bilateral augmentation in activity accompanied by an increase in fractional anisotropy (FA) within the contralateral SI. Increases of white matter fractional anisotropy were also observed in the secondary somatosensory area (SII) and the thalamus. Outside of somatosensory system, changes in both structure and function were found in i.e., the fusiform gyrus, the medial frontal gyri and the inferior parietal lobule. Our results provide evidence for functional remodeling of the somatosensory pathway and higher ordered multimodal brain areas occurring as a result of short-lasting tactile learning, and add to them a novel picture of extensive white matter plasticity.

  3. TAREAN: a computational tool for identification and characterization of satellite DNA from unassembled short reads.

    Science.gov (United States)

    Novák, Petr; Ávila Robledillo, Laura; Koblížková, Andrea; Vrbová, Iva; Neumann, Pavel; Macas, Jirí

    2017-07-07

    Satellite DNA is one of the major classes of repetitive DNA, characterized by tandemly arranged repeat copies that form contiguous arrays up to megabases in length. This type of genomic organization makes satellite DNA difficult to assemble, which hampers characterization of satellite sequences by computational analysis of genomic contigs. Here, we present tandem repeat analyzer (TAREAN), a novel computational pipeline that circumvents this problem by detecting satellite repeats directly from unassembled short reads. The pipeline first employs graph-based sequence clustering to identify groups of reads that represent repetitive elements. Putative satellite repeats are subsequently detected by the presence of circular structures in their cluster graphs. Consensus sequences of repeat monomers are then reconstructed from the most frequent k-mers obtained by decomposing read sequences from corresponding clusters. The pipeline performance was successfully validated by analyzing low-pass genome sequencing data from five plant species where satellite DNA was previously experimentally characterized. Moreover, novel satellite repeats were predicted for the genome of Vicia faba and three of these repeats were verified by detecting their sequences on metaphase chromosomes using fluorescence in situ hybridization. © The Author(s) 2017. Published by Oxford University Press on behalf of Nucleic Acids Research.

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

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

  6. GenHtr: a tool for comparative assessment of genetic heterogeneity in microbial genomes generated by massive short-read sequencing

    Directory of Open Access Journals (Sweden)

    Yu GongXin

    2010-10-01

    Full Text Available Abstract Background Microevolution is the study of short-term changes of alleles within a population and their effects on the phenotype of organisms. The result of the below-species-level evolution is heterogeneity, where populations consist of subpopulations with a large number of structural variations. Heterogeneity analysis is thus essential to our understanding of how selective and neutral forces shape bacterial populations over a short period of time. The Solexa Genome Analyzer, a next-generation sequencing platform, allows millions of short sequencing reads to be obtained with great accuracy, allowing for the ability to study the dynamics of the bacterial population at the whole genome level. The tool referred to as GenHtr was developed for genome-wide heterogeneity analysis. Results For particular bacterial strains, GenHtr relies on a set of Solexa short reads on given bacteria pathogens and their isogenic reference genome to identify heterogeneity sites, the chromosomal positions with multiple variants of genes in the bacterial population, and variations that occur in large gene families. GenHtr accomplishes this by building and comparatively analyzing genome-wide heterogeneity genotypes for both the newly sequenced genomes (using massive short-read sequencing and their isogenic reference (using simulated data. As proof of the concept, this approach was applied to SRX007711, the Solexa sequencing data for a newly sequenced Staphylococcus aureus subsp. USA300 cell line, and demonstrated that it could predict such multiple variants. They include multiple variants of genes critical in pathogenesis, e.g. genes encoding a LysR family transcriptional regulator, 23 S ribosomal RNA, and DNA mismatch repair protein MutS. The heterogeneity results in non-synonymous and nonsense mutations, leading to truncated proteins for both LysR and MutS. Conclusion GenHtr was developed for genome-wide heterogeneity analysis. Although it is much more time

  7. Whole genome assembly of a natto production strain Bacillus subtilis natto from very short read data.

    Science.gov (United States)

    Nishito, Yukari; Osana, Yasunori; Hachiya, Tsuyoshi; Popendorf, Kris; Toyoda, Atsushi; Fujiyama, Asao; Itaya, Mitsuhiro; Sakakibara, Yasubumi

    2010-04-16

    Bacillus subtilis natto is closely related to the laboratory standard strain B. subtilis Marburg 168, and functions as a starter for the production of the traditional Japanese food "natto" made from soybeans. Although re-sequencing whole genomes of several laboratory domesticated B. subtilis 168 derivatives has already been attempted using short read sequencing data, the assembly of the whole genome sequence of a closely related strain, B. subtilis natto, from very short read data is more challenging, particularly with our aim to assemble one fully connected scaffold from short reads around 35 bp in length. We applied a comparative genome assembly method, which combines de novo assembly and reference guided assembly, to one of the B. subtilis natto strains. We successfully assembled 28 scaffolds and managed to avoid substantial fragmentation. Completion of the assembly through long PCR experiments resulted in one connected scaffold for B. subtilis natto. Based on the assembled genome sequence, our orthologous gene analysis between natto BEST195 and Marburg 168 revealed that 82.4% of 4375 predicted genes in BEST195 are one-to-one orthologous to genes in 168, with two genes in-paralog, 3.2% are deleted in 168, 14.3% are inserted in BEST195, and 5.9% of genes present in 168 are deleted in BEST195. The natto genome contains the same alleles in the promoter region of degQ and the coding region of swrAA as the wild strain, RO-FF-1. These are specific for gamma-PGA production ability, which is related to natto production. Further, the B. subtilis natto strain completely lacked a polyketide synthesis operon, disrupted the plipastatin production operon, and possesses previously unidentified transposases. The determination of the whole genome sequence of Bacillus subtilis natto provided detailed analyses of a set of genes related to natto production, demonstrating the number and locations of insertion sequences that B. subtilis natto harbors but B. subtilis 168 lacks

  8. Whole genome assembly of a natto production strain Bacillus subtilis natto from very short read data

    Directory of Open Access Journals (Sweden)

    Fujiyama Asao

    2010-04-01

    Full Text Available Abstract Background Bacillus subtilis natto is closely related to the laboratory standard strain B. subtilis Marburg 168, and functions as a starter for the production of the traditional Japanese food "natto" made from soybeans. Although re-sequencing whole genomes of several laboratory domesticated B. subtilis 168 derivatives has already been attempted using short read sequencing data, the assembly of the whole genome sequence of a closely related strain, B. subtilis natto, from very short read data is more challenging, particularly with our aim to assemble one fully connected scaffold from short reads around 35 bp in length. Results We applied a comparative genome assembly method, which combines de novo assembly and reference guided assembly, to one of the B. subtilis natto strains. We successfully assembled 28 scaffolds and managed to avoid substantial fragmentation. Completion of the assembly through long PCR experiments resulted in one connected scaffold for B. subtilis natto. Based on the assembled genome sequence, our orthologous gene analysis between natto BEST195 and Marburg 168 revealed that 82.4% of 4375 predicted genes in BEST195 are one-to-one orthologous to genes in 168, with two genes in-paralog, 3.2% are deleted in 168, 14.3% are inserted in BEST195, and 5.9% of genes present in 168 are deleted in BEST195. The natto genome contains the same alleles in the promoter region of degQ and the coding region of swrAA as the wild strain, RO-FF-1. These are specific for γ-PGA production ability, which is related to natto production. Further, the B. subtilis natto strain completely lacked a polyketide synthesis operon, disrupted the plipastatin production operon, and possesses previously unidentified transposases. Conclusions The determination of the whole genome sequence of Bacillus subtilis natto provided detailed analyses of a set of genes related to natto production, demonstrating the number and locations of insertion sequences that B

  9. The genome of flax (Linum usitatissimum) assembled de novo from short shotgun sequence reads

    DEFF Research Database (Denmark)

    Wang, Zhiwen; Hobson, Neil; Galindo, Leonardo

    2012-01-01

    Flax (Linum usitatissimum) is an ancient crop that is widely cultivated as a source of fiber, oil and medicinally relevant compounds. To accelerate crop improvement, we performed whole-genome shotgun sequencing of the nuclear genome of flax. Seven paired-end libraries ranging in size from 300 bp...... these results show that de novo assembly, based solely on whole-genome shotgun short-sequence reads, is an efficient means of obtaining nearly complete genome sequence information for some plant species....

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

  11. Phonological working memory and reading in students with dyslexia

    Directory of Open Access Journals (Sweden)

    Carolina Alves Ferreira De Carvalho

    2014-07-01

    Full Text Available Purpose: To investigate parameters related to fluency, reading comprehension and phonological processing (operational and short-term memory and identify potential correlation between the variables in Dyslexia and in the absence of reading difficulties. Method: One hundred and fifteen students from the third to eighth grade of elementary school were grouped into a Control Group (CG and Group with Dyslexia (GDys. Reading of words, pseudowords and text (decoding; listening and reading comprehension; phonological short-term and working memory (repetition of pseudowords and Digit Span were evaluated. Results: The comparison of the groups showed significant differences in decoding, phonological short-term memory (repetition of pseudowords and answers to text-connecting questions (TC on reading comprehension, with the worst performances identified for GDys. In this group there were negative correlations between pseudowords repetition and TC answers and total score, both on listening comprehension. No correlations were found between operational and short-term memory (Digit Span and parameters of fluency and reading comprehension in dyslexia. For the sample without complaint, there were positive correlations between some parameters of reading fluency and repetition of pseudowords and also between answering literal questions in listening comprehension and repetition of digits on the direct and reverse order. There was no correlation with the parameters of reading comprehension. Conclusion: GDys and CG showed similar performance in listening comprehension and in understanding of explicit information and gap-filling inference on reading comprehension. Students of GDys showed worst performance in reading decoding, phonological short-term memory (pseudowords and on inferences that depends on textual cohesion understanding in reading. There were negative correlations between pseudowords repetition and TC answers and total score, both in listening comprehension.

  12. Phonological working memory and reading in students with dyslexia.

    Science.gov (United States)

    de Carvalho, Carolina A F; Kida, Adriana de S B; Capellini, Simone A; de Avila, Clara R B

    2014-01-01

    To investigate parameters related to fluency, reading comprehension and phonological processing (operational and short-term memory) and identify potential correlation between the variables in Dyslexia and in the absence of reading difficulties. One hundred and fifteen students from the third to eighth grade of elementary school were grouped into a Control Group (CG) and Group with Dyslexia (GDys). Reading of words, pseudowords and text (decoding); listening and reading comprehension; phonological short-term and working memory (repetition of pseudowords and Digit Span) were evaluated. The comparison of the groups showed significant differences in decoding, phonological short-term memory (repetition of pseudowords) and answers to text-connecting questions (TC) on reading comprehension, with the worst performances identified for GDys. In this group there were negative correlations between pseudowords repetition and TC answers and total score, both on listening comprehension. No correlations were found between operational and short-term memory (Digit Span) and parameters of fluency and reading comprehension in dyslexia. For the sample without complaint, there were positive correlations between some parameters of reading fluency and repetition of pseudowords and also between answering literal questions in listening comprehension and repetition of digits on the direct and reverse order. There was no correlation with the parameters of reading comprehension. GDys and CG showed similar performance in listening comprehension and in understanding of explicit information and gap-filling inference on reading comprehension. Students of GDys showed worst performance in reading decoding, phonological short-term memory (pseudowords) and on inferences that depends on textual cohesion understanding in reading. There were negative correlations between pseudowords repetition and TC answers and total score, both in listening comprehension.

  13. The Short Circuit Model of Reading.

    Science.gov (United States)

    Lueers, Nancy M.

    The name "short circuit" has been given to this model because, in many ways, it adequately describes what happens bioelectrically in the brain. The "short-circuiting" factors include linguistic, sociocultural, attitudinal and motivational, neurological, perceptual, and cognitive factors. Research is reviewed on ways in which each one affects any…

  14. Some indicators of (unsuccessful reading

    Directory of Open Access Journals (Sweden)

    Vuksanović Jasmina

    2008-01-01

    Full Text Available In the paper we set the aim to determine whether phonological awareness and short-term verbal memory are indicators of a subsequent reading acquisition. The sample consisted of 194 first graders from two primary schools in Belgrade. The results of our research showed that the most significant indicator of the subsequent (unsuccessful reading was phonological awareness. The short-term verbal memory is, to a lesser extent, an indicator of the subsequent reading acquisition defined by the time needed for reading the text and by the text comprehension. Our findings offer basis for proposing that the phonological awareness assessment should be implemented into the regular procedure of assessing child's readiness for school. In this way children in need for preventive stimulation within the inclusive programme in primary schools could be identified.

  15. Nonword Repetition: The Relative Contributions of Phonological Short-Term Memory and Phonological Representations in Children with Language and Reading Impairment

    Science.gov (United States)

    Rispens, Judith; Baker, Anne

    2012-01-01

    Purpose: This study investigates the relative contributions of phonological short-term memory and phonological representations to nonword repetition (NWR). This was evaluated in children with specific language impairment (SLI) and/or reading impairment (RI); it was also studied from a developmental perspective by comparing 2 groups of typically…

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

  17. Short-wavelength magnetic recording new methods and analyses

    CERN Document Server

    Ruigrok, JJM

    2013-01-01

    Short-wavelength magnetic recording presents a series of practical solutions to a wide range of problems in the field of magnetic recording. It features many new and original results, all derived from fundamental principles as a result of up-to-date research.A special section is devoted to the playback process, including the calculations of head efficiency and head impedance, derived from new theorems.Features include:A simple and fast method for measuring efficiency; a simple method for the accurate separation of the read and write behaviour of magnetic heads; a new concept - the bandpass hea

  18. The genome of flax (Linum usitatissimum) assembled de novo from short shotgun sequence reads.

    Science.gov (United States)

    Wang, Zhiwen; Hobson, Neil; Galindo, Leonardo; Zhu, Shilin; Shi, Daihu; McDill, Joshua; Yang, Linfeng; Hawkins, Simon; Neutelings, Godfrey; Datla, Raju; Lambert, Georgina; Galbraith, David W; Grassa, Christopher J; Geraldes, Armando; Cronk, Quentin C; Cullis, Christopher; Dash, Prasanta K; Kumar, Polumetla A; Cloutier, Sylvie; Sharpe, Andrew G; Wong, Gane K-S; Wang, Jun; Deyholos, Michael K

    2012-11-01

    Flax (Linum usitatissimum) is an ancient crop that is widely cultivated as a source of fiber, oil and medicinally relevant compounds. To accelerate crop improvement, we performed whole-genome shotgun sequencing of the nuclear genome of flax. Seven paired-end libraries ranging in size from 300 bp to 10 kb were sequenced using an Illumina genome analyzer. A de novo assembly, comprised exclusively of deep-coverage (approximately 94× raw, approximately 69× filtered) short-sequence reads (44-100 bp), produced a set of scaffolds with N(50) =694 kb, including contigs with N(50)=20.1 kb. The contig assembly contained 302 Mb of non-redundant sequence representing an estimated 81% genome coverage. Up to 96% of published flax ESTs aligned to the whole-genome shotgun scaffolds. However, comparisons with independently sequenced BACs and fosmids showed some mis-assembly of regions at the genome scale. A total of 43384 protein-coding genes were predicted in the whole-genome shotgun assembly, and up to 93% of published flax ESTs, and 86% of A. thaliana genes aligned to these predicted genes, indicating excellent coverage and accuracy at the gene level. Analysis of the synonymous substitution rates (K(s) ) observed within duplicate gene pairs was consistent with a recent (5-9 MYA) whole-genome duplication in flax. Within the predicted proteome, we observed enrichment of many conserved domains (Pfam-A) that may contribute to the unique properties of this crop, including agglutinin proteins. Together these results show that de novo assembly, based solely on whole-genome shotgun short-sequence reads, is an efficient means of obtaining nearly complete genome sequence information for some plant species. © 2012 The Authors. The Plant Journal © 2012 Blackwell Publishing Ltd.

  19. ReadDepth: a parallel R package for detecting copy number alterations from short sequencing reads.

    Directory of Open Access Journals (Sweden)

    Christopher A Miller

    2011-01-01

    Full Text Available Copy number alterations are important contributors to many genetic diseases, including cancer. We present the readDepth package for R, which can detect these aberrations by measuring the depth of coverage obtained by massively parallel sequencing of the genome. In addition to achieving higher accuracy than existing packages, our tool runs much faster by utilizing multi-core architectures to parallelize the processing of these large data sets. In contrast to other published methods, readDepth does not require the sequencing of a reference sample, and uses a robust statistical model that accounts for overdispersed data. It includes a method for effectively increasing the resolution obtained from low-coverage experiments by utilizing breakpoint information from paired end sequencing to do positional refinement. We also demonstrate a method for inferring copy number using reads generated by whole-genome bisulfite sequencing, thus enabling integrative study of epigenomic and copy number alterations. Finally, we apply this tool to two genomes, showing that it performs well on genomes sequenced to both low and high coverage. The readDepth package runs on Linux and MacOSX, is released under the Apache 2.0 license, and is available at http://code.google.com/p/readdepth/.

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

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

  2. The role of visual processing speed in reading speed development.

    Science.gov (United States)

    Lobier, Muriel; Dubois, Matthieu; Valdois, Sylviane

    2013-01-01

    A steady increase in reading speed is the hallmark of normal reading acquisition. However, little is known of the influence of visual attention capacity on children's reading speed. The number of distinct visual elements that can be simultaneously processed at a glance (dubbed the visual attention span), predicts single-word reading speed in both normal reading and dyslexic children. However, the exact processes that account for the relationship between the visual attention span and reading speed remain to be specified. We used the Theory of Visual Attention to estimate visual processing speed and visual short-term memory capacity from a multiple letter report task in eight and nine year old children. The visual attention span and text reading speed were also assessed. Results showed that visual processing speed and visual short term memory capacity predicted the visual attention span. Furthermore, visual processing speed predicted reading speed, but visual short term memory capacity did not. Finally, the visual attention span mediated the effect of visual processing speed on reading speed. These results suggest that visual attention capacity could constrain reading speed in elementary school children.

  3. The role of visual processing speed in reading speed development.

    Directory of Open Access Journals (Sweden)

    Muriel Lobier

    Full Text Available A steady increase in reading speed is the hallmark of normal reading acquisition. However, little is known of the influence of visual attention capacity on children's reading speed. The number of distinct visual elements that can be simultaneously processed at a glance (dubbed the visual attention span, predicts single-word reading speed in both normal reading and dyslexic children. However, the exact processes that account for the relationship between the visual attention span and reading speed remain to be specified. We used the Theory of Visual Attention to estimate visual processing speed and visual short-term memory capacity from a multiple letter report task in eight and nine year old children. The visual attention span and text reading speed were also assessed. Results showed that visual processing speed and visual short term memory capacity predicted the visual attention span. Furthermore, visual processing speed predicted reading speed, but visual short term memory capacity did not. Finally, the visual attention span mediated the effect of visual processing speed on reading speed. These results suggest that visual attention capacity could constrain reading speed in elementary school children.

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

  5. Design of short Italian sentences to assess near vision performance.

    Science.gov (United States)

    Calossi, Antonio; Boccardo, Laura; Fossetti, Alessandro; Radner, Wolfgang

    2014-01-01

    To develop and validate 28 short Italian sentences for the construction of the Italian version of the Radner Reading Chart to simultaneously measure near visual acuity and reading speed. 41 sentences were constructed in Italian language, following the procedure defined by Radner, to obtain "sentence optotypes" with comparable structure and with the same lexical and grammatical difficulty. Sentences were statistically selected and used in 211 normal, non-presbyopic, native Italian-speaking persons. The most equally matched sentences in terms of reading speed and number of reading errors were selected. To assess the validity of the reading speed results obtained with the 28 selected short sentences, we compared the reading speed and reading errors with the average obtained by reading two long 4th-grade paragraphs (97 and 90 words) under the same conditions. The overall mean reading speed of the tested persons was 189±26wpm. The 28 sentences more similar in terms of reading times were selected, achieving a coefficient of variation (the relative SD) of 2.2%. The reliability analyses yielded an overall Cronbach's alpha coefficient of 0.98. The correlation between the short sentences and the long paragraph was high (r=0.85, P<0.0001). The 28 short single Italian sentences optotypes were highly comparable in syntactical structure, number, position, and length of words, lexical difficulty, and reading length. The resulting Italian Radner Reading Chart is precise (high consistency) and practical (short sentences) and therefore useful for research and clinical practice to simultaneously measure near reading acuity and reading speed. Copyright © 2013 Spanish General Council of Optometry. Published by Elsevier Espana. All rights reserved.

  6. Mini-Mental Status Examination: a short form of MMSE was as accurate as the original MMSE in predicting dementia

    DEFF Research Database (Denmark)

    Schultz-Larsen, Kirsten; Lomholt, Rikke Kirstine; Kreiner, Svend

    2006-01-01

    .4%), and positive predictive value (71.0%) but equal area under the receiver operating characteristic curve. Cross-validation on follow-up data confirmed the results. CONCLUSION: A short, valid MMSE, which is as sensitive and specific as the original MMSE for the screening of cognitive impairments and dementia......OBJECTIVES: This study assesses the properties of the Mini-Mental State Examination (MMSE) with the purpose of improving the efficiencies of the methods of screening for cognitive impairment and dementia. A specific purpose was to determine whether an abbreviated version would be as accurate...... is attractive for research and clinical practice, particularly if predictive power can be enhanced by combining the short MMSE with neuropsychological tests or informant reports....

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

  8. Grade 12 Diploma Examination, English 30. Part B: Reading (Multiple Choice). Readings Booklet. 1986 Edition.

    Science.gov (United States)

    Alberta Dept. of Education, Edmonton.

    Intended for students taking the Grade 12 Examination in English 30 in Alberta, Canada, this reading test (to be administered along with the questions booklet) contains 10 short reading selections taken from fiction, nonfiction, poetry, and drama, including the following: "My Magical Metronome" (Lewis Thomas); "Queen Street…

  9. Reading Self-Efficacy Predicts Word Reading But Not Comprehension in Both Girls and Boys.

    Science.gov (United States)

    Carroll, Julia M; Fox, Amy C

    2016-01-01

    The relationship between cognitive skills and reading has been well-established. However, the role of motivational factors such as self-efficacy in reading progress is less clear. In particular, it is not clear how self-efficacy relates to word level reading versus comprehension, and whether this differs in boys and girls. This study examines the relationship between self-efficacy, word reading and reading comprehension across the range of reading abilities after controlling for reading-related cognitive factors. One hundred and seventy nine children (86 males and 93 females) between 8 and 11 years old completed a self-report measure of reading self-efficacy together with measures of reading comprehension and word reading, working memory, auditory short-term memory, phonological awareness, and vocabulary. Boys and girls showed similar levels of attainment and reading self-efficacy. Reading self-efficacy was associated with word reading, but not with reading comprehension in either boys or girls. It is argued that this may reflect important differences between reading self-efficacy and more general measures of reading motivation and engagement. Reading self-efficacy is an element of reading motivation that is closely associated with a child's perceived attainments in reading and is less susceptible to the gender differences seen in broader measures.

  10. Reading Self-Efficacy Predicts Word Reading But Not Comprehension in Both Girls and Boys

    Science.gov (United States)

    Carroll, Julia M.; Fox, Amy C.

    2017-01-01

    The relationship between cognitive skills and reading has been well-established. However, the role of motivational factors such as self-efficacy in reading progress is less clear. In particular, it is not clear how self-efficacy relates to word level reading versus comprehension, and whether this differs in boys and girls. This study examines the relationship between self-efficacy, word reading and reading comprehension across the range of reading abilities after controlling for reading-related cognitive factors. One hundred and seventy nine children (86 males and 93 females) between 8 and 11 years old completed a self-report measure of reading self-efficacy together with measures of reading comprehension and word reading, working memory, auditory short-term memory, phonological awareness, and vocabulary. Boys and girls showed similar levels of attainment and reading self-efficacy. Reading self-efficacy was associated with word reading, but not with reading comprehension in either boys or girls. It is argued that this may reflect important differences between reading self-efficacy and more general measures of reading motivation and engagement. Reading self-efficacy is an element of reading motivation that is closely associated with a child’s perceived attainments in reading and is less susceptible to the gender differences seen in broader measures. PMID:28144223

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

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

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

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

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

  16. The Effect of Reading a Short Passage of Literary Fiction on Theory of Mind: A Replication of Kidd and Castano (2013

    Directory of Open Access Journals (Sweden)

    Iris van Kuijk

    2018-02-01

    Full Text Available The results reported by Kidd and Castano (2013 indicated that reading a short passage of literary fiction improves theory of mind (ToM relative to reading popular fiction. However, when we entered Kidd and Castano’s results in a 'p'-curve analysis, it turned out that the evidential value of their findings is low. It is good practice to back up a p-curve analysis of a single paper with an adequately powered direct replication of at least one of the studies in the 'p'-curve analysis. Therefore, we conducted a direct replication of the literary fiction condition and the popular fiction condition from Kidd and Castano’s Experiment 5 to scrutinize the effect of reading literary fiction on ToM. The results of this replication were largely consistent with Kidd and Castano’s original findings. Furthermore, we conducted a small-scale meta-analysis on the findings of the present study, those of Kidd and Castano and those reported in other published direct replications. The meta-analytic effect of reading literary fiction on ToM was small and non-significant but there was considerable heterogeneity between the included studies. The results of the present study and of the small-scale meta-analysis are discussed in the light of reading-times exclusion criteria as well as reliability and validity of ToM measures.

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

  18. Validation of a Supplemental Reading Intervention for First-Grade Children

    OpenAIRE

    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 conditions. Students in the intervention received 16 hours of instruction. Analyses of pre- and posttest data and growth measures suggest that short-term sup...

  19. Using the Dictionary for Improving Adolescents’ Reading Comprehension of Short Scientific Texts

    Directory of Open Access Journals (Sweden)

    Becerra Cortés Ximena

    2013-10-01

    Full Text Available This paper reports on an innovative and action research project which focused on the use of the dictionary and the prior knowledge of Colombian high school students to improve their reading comprehension of short scientific texts. Data collection instruments included students’ work gathered during two workshops, field notes, and a questionnaire. Findings showed that searching in the dictionary and activating prior knowledge seem to facilitate the use of the text to answer reading comprehension questions. Students experienced less difficulty answering questions that required literal information than those that required establishing relationships among elements of the text. They equally valued the prior knowledge of the subject and the use of the dictionary in the resolution of science workshops in English.En este artículo se reporta un proyecto de innovación y de investigación acción centrado en el uso del diccionario y el conocimiento previo adquirido de estudiantes colombianos de secundaria para mejorar la comprensión lectora de textos científicos cortos. Los instrumentos de recolección de datos incluyen el trabajo realizado por los estudiantes durante dos talleres, notas de campo y un cuestionario. Los resultados mostraron que la consulta del diccionario y la activación de conocimientos previos parecen facilitar el uso del texto para responder preguntas de comprensión de lectura. Los estudiantes encontraron menor dificultad en la resolución de preguntas que requerían información literal que en aquellas que implicaban el establecimiento de relaciones entre los elementos del texto. Ellos valoran por igual el conocimiento previo y el uso del diccionario en la resolución de talleres de Ciencias en inglés.

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

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

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

  3. Evaluation of Short Term Memory Span Function In Children

    OpenAIRE

    Barış ERGÜL; Arzu ALTIN YAVUZ; Ebru GÜNDOĞAN AŞIK

    2016-01-01

    Although details of the information encoded in the short-term memory where it is stored temporarily be recorded in the working memory in the next stage. Repeating the information mentally makes it remain in memory for a long time. Studies investigating the relationship between short-term memory and reading skills that are carried out to examine the relationship between short-term memory processes and reading comprehension. In this study information coming to short-term memory and the factors ...

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

  5. Evaluation of Short Term Memory Span Function In Children

    Directory of Open Access Journals (Sweden)

    Barış ERGÜL

    2016-12-01

    Full Text Available Although details of the information encoded in the short-term memory where it is stored temporarily be recorded in the working memory in the next stage. Repeating the information mentally makes it remain in memory for a long time. Studies investigating the relationship between short-term memory and reading skills that are carried out to examine the relationship between short-term memory processes and reading comprehension. In this study information coming to short-term memory and the factors affecting operation of short term memory are investigated with regression model. The aim of the research is to examine the factors (age, IQ and reading skills that are expected the have an effect on short-term memory in children through regression analysis. One of the assumptions of regression analysis is to examine which has constant variance and normal distribution of the error term. In this study, because the error term is not normally distributed, robust regression techniques were applied. Also, for each technique; coefficient of determination is determined. According to the findings, the increase in age, IQ and reading skills caused the increase in short term memory in children. After applying robust regression techniques, the Winsorized Least Squares (WLS technique gives the highest coefficient of determination.

  6. In silico serotyping of E. coli from short read data identifies limited novel O-loci but extensive diversity of O:H serotype combinations within and between pathogenic lineages.

    Science.gov (United States)

    Ingle, Danielle J; Valcanis, Mary; Kuzevski, Alex; Tauschek, Marija; Inouye, Michael; Stinear, Tim; Levine, Myron M; Robins-Browne, Roy M; Holt, Kathryn E

    2016-07-01

    The lipopolysaccharide (O) and flagellar (H) surface antigens of Escherichia coli are targets for serotyping that have traditionally been used to identify pathogenic lineages. These surface antigens are important for the survival of E. coli within mammalian hosts. However, traditional serotyping has several limitations, and public health reference laboratories are increasingly moving towards whole genome sequencing (WGS) to characterize bacterial isolates. Here we present a method to rapidly and accurately serotype E. coli isolates from raw, short read WGS data. Our approach bypasses the need for de novo genome assembly by directly screening WGS reads against a curated database of alleles linked to known and novel E. coli O-groups and H-types (the EcOH database) using the software package srst2. We validated the approach by comparing in silico results for 197 enteropathogenic E. coli isolates with those obtained by serological phenotyping in an independent laboratory. We then demonstrated the utility of our method to characterize isolates in public health and clinical settings, and to explore the genetic diversity of >1500 E. coli genomes from multiple sources. Importantly, we showed that transfer of O- and H-antigen loci between E. coli chromosomal backbones is common, with little evidence of constraints by host or pathotype, suggesting that E. coli ' strain space' may be virtually unlimited, even within specific pathotypes. Our findings show that serotyping is most useful when used in combination with strain genotyping to characterize microevolution events within an inferred population structure.

  7. MetaVelvet: An Extension of Velvet Assembler to de novo Metagenome Assembly from Short Sequence Reads (Metagenomics Informatics Challenges Workshop: 10K Genomes at a Time)

    Energy Technology Data Exchange (ETDEWEB)

    Sakakibara, Yasumbumi

    2011-10-13

    Keio University's Yasumbumi Sakakibara on "MetaVelvet: An Extension of Velvet Assembler to de novo Metagenome Assembly from Short Sequence Reads" at the Metagenomics Informatics Challenges Workshop held at the DOE JGI on October 12-13, 2011.

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

  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. There are multiple contributors to the verbal short-term memory deficit in children with developmental reading disabilities.

    Science.gov (United States)

    Kibby, Michelle Y

    2009-09-01

    Prior research has put forth at least four possible contributors to the verbal short-term memory (VSTM) deficit in children with developmental reading disabilities (RD): poor phonological awareness that affects phonological coding into VSTM, a less effective phonological store, slow articulation rate, and fewer/poorer quality long-term memory (LTM) representations. This project is among the first to test the four suppositions in one study. Participants included 18 children with RD and 18 controls. VSTM was assessed using Baddeley's model of the phonological loop. Findings suggest all four suppositions are correct, depending upon the type of material utilized. Children with RD performed comparably to controls in VSTM for common words but worse for less frequent words and nonwords. Furthermore, only articulation rate predicted VSTM for common words, whereas Verbal IQ and articulation rate predicted VSTM for less frequent words, and phonological awareness and articulation rate predicted VSTM for nonwords. Overall, findings suggest that the mechanism(s) used to code and store items by their meaning is intact in RD, and the deficit in VSTM for less frequent words may be a result of fewer/poorer quality LTM representations for these words. In contrast, phonological awareness and the phonological store are impaired, affecting VSTM for items that are coded phonetically. Slow articulation rate likely affects VSTM for most material when present. When assessing reading performance, VSTM predicted decoding skill but not word identification after controlling Verbal IQ and phonological awareness. Thus, VSTM likely contributes to reading ability when words are novel and must be decoded.

  11. The contribution of phonological awareness and receptive and expressive english to the reading ability of deaf students with varying degrees of exposure to accurate english.

    Science.gov (United States)

    Luetke-Stahlman, Barbara; Nielsen, Diane Corcoran

    2003-01-01

    This study was planned with the knowledge that the tasks of reading require the same acquisition of skills, whether a child is hearing or deaf, monolingual, or bilingual. Reading and language research literature was reviewed. Subjects were 31 deaf students (7.9-17.9 years of age) who attended one of three U.S. programs. Performance on 15 language and literacy measures was analyzed. Results were that students who scored highest on a passage-comprehension measure also were more able (a) to provide synonyms, antonyms, and analogies of read words and phrases, (b) to read more listed words, and (c) to substitute one phoneme more correctly for another to create new words than were readers with lower scores. Two groups of students also were compared: a Longer Exposure to English Group (n = 22) who used Signing Exact English (SEE) for 5 years or more and a Shorter Exposure Group (n = 8) exposed to SEE for less than 2 years. A correlational analysis revealed that there were no significant relationships among 14 background variables with the exception of "age of identification of hearing loss," a variable then covaried in subsequent analysis of covariance. Students in the Longer Exposure Group scored higher on all measures. Significant differences were found between groups for short-term memory, receptive and expressive English, and five phonological subtests. Mini-case studies and the performance of eight students in the Longer Exposure Group who scored lowest on the comprehension measure also are discussed.

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

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

  14. The influence of working memory on reading growth in subgroups of children with reading disabilities.

    Science.gov (United States)

    Swanson, H Lee; Jerman, Olga

    2007-04-01

    This 3-year longitudinal study determined whether (a) subgroups of children with reading disabilities (RD) (children with RD only, children with both reading and arithmetic deficits, and low verbal IQ readers) and skilled readers varied in working memory (WM) and short-term memory (STM) growth and (b) whether growth in an executive system and/or a phonological storage system mediated growth in reading performance. A battery of memory and reading measures was administered to 84 children (11-17 years of age) across three testing waves spaced 1 year apart. The results showed that skilled readers yielded higher WM growth estimates than did the RD groups. No significant differentiation among subgroups of children with RD on growth measures emerged. Hierarchical linear modeling showed that WM (controlled attention), rather than STM (phonological loop), was related to growth in reading comprehension and reading fluency. The results support the notion that deficient growth in the executive component of WM underlies RD.

  15. Investigation of the Effect of Using a Novel as an Extensive Reading on Students’ Attitudes and Reading Ability

    Directory of Open Access Journals (Sweden)

    Shima Ghiabi

    2014-07-01

    Full Text Available The present study aims at investigating learners’ perceptions on the use of a novel as an extensive reading in a college EFL reading course. For this purpose, fifty Iranian EFL students read and received instructions on an unabridged short novel in addition to, their text book for one semester. Three questionnaires were used to measure students’ attitudes toward novel-reading, students’ confidence in novel reading ability and students’ perceptions toward using a novel as an auxiliary material, prior to and after reading the novel. In addition, three open questions were offered to obtain benefits and obstacles of the novel reading. T-test analysis were used and findings revealed that there was a significant improvement after reading the novel in students’ attitudes, confidence, interest and their novel-reading ability. However, they suggested reading the novels according to the theme that they preferred. The result of this study are of pedagogic significance to EFL teaching in that they indicated how well a novel was received in an EFL Advanced reading class.

  16. Semantic interference in picture naming during dual-task performance does not vary with reading ability.

    Science.gov (United States)

    Piai, Vitória; Roelofs, Ardi; Roete, Ingeborg

    2015-01-01

    Previous dual-task studies examining the locus of semantic interference of distractor words in picture naming have obtained diverging results. In these studies, participants manually responded to tones and named pictures while ignoring distractor words (picture-word interference, PWI) with varying stimulus onset asynchrony (SOA) between tone and PWI stimulus. Whereas some studies observed no semantic interference at short SOAs, other studies observed effects of similar magnitude at short and long SOAs. The absence of semantic interference in some studies may perhaps be due to better reading skill of participants in these than in the other studies. According to such a reading-ability account, participants' reading skill should be predictive of the magnitude of their interference effect at short SOAs. To test this account, we conducted a dual-task study with tone discrimination and PWI tasks and measured participants' reading ability. The semantic interference effect was of similar magnitude at both short and long SOAs. Participants' reading ability was predictive of their naming speed but not of their semantic interference effect, contrary to the reading ability account. We conclude that the magnitude of semantic interference in picture naming during dual-task performance does not depend on reading skill.

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

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

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

  20. A case of exceptional reading accuracy in a child with Down syndrome – underlying skills and the relation to reading comprehension

    NARCIS (Netherlands)

    Groen, M.A.; Laws, G.; Nation, K.; Bishop, D.V.M.

    2006-01-01

    We report on a case of a girl with Down syndrome (DS), K.S., whose reading accuracy is exceptional. This ability is associated with robust phonological skills and relative strengths in visual and verbal short-term memory, articulation, and speech fluency. Although her reading comprehension is age

  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. Reading in Developmental Prosopagnosia: Evidence for a Dissociation Between Word and Face Recognition

    DEFF Research Database (Denmark)

    Starrfelt, Randi; Klargaard, Solja; Petersen, Anders

    2018-01-01

    exposure durations (targeting the word superiority effect), and d) text reading. Results: Participants with developmental prosopagnosia performed strikingly similar to controls across the four reading tasks. Formal analysis revealed a significant dissociation between word and face recognition......, that is, impaired reading in developmental prosopagnosia. Method: We tested 10 adults with developmental prosopagnosia and 20 matched controls. All participants completed the Cambridge Face Memory Test, the Cambridge Face Perception test and a Face recognition questionnaire used to quantify everyday face...... recognition experience. Reading was measured in four experimental tasks, testing different levels of letter, word, and text reading: a) single word reading with words of varying length, b) vocal response times in single letter and short word naming, c) recognition of single letters and short words at brief...

  3. The effect of word length and other sublexical, lexical, and semantic variables on developmental reading deficits.

    Science.gov (United States)

    De Luca, Maria; Barca, Laura; Burani, Cristina; Zoccolotti, Pierluigi

    2008-12-01

    To examine the effect of word length and several sublexical, and lexico-semantic variables on the reading of Italian children with a developmental reading deficit. Previous studies indicated the role of word length in transparent orthographies. However, several factors that may interact with word length were not controlled for. Seventeen impaired and 34 skilled sixth-grade readers were presented words of different lengths, matched for initial phoneme, bigram frequency, word frequency, age of acquisition, and imageability. Participants were asked to read aloud, as quickly and as accurately as possible. Reaction times at the onset of pronunciation and mispronunciations were recorded. Impaired readers' reaction times indicated a marked effect of word length; in skilled readers, there was no length effect for short words but, rather, a monotonic increase from 6-letter words on. Regression analyses confirmed the role of word length and indicated the influence of word frequency (similar in impaired and skilled readers). No other variables predicted reading latencies. Word length differentially influenced word recognition in impaired versus skilled readers, irrespective of the action of (potentially interfering) sublexical, lexical, and semantic variables. It is proposed that the locus of the length effect is at a perceptual level of analysis. The independent influence of word frequency on the reading performance of both groups of participants indicates the sparing of lexical activation in impaired readers.

  4. The Short Readings Project: A CALL Reading Activity Utilizing Vocabulary Recycling

    Science.gov (United States)

    Johnson, Andrew; Heffernan, Neil

    2006-01-01

    In 2003 multimedia-based English Trailers (www.english-trailers.com) joined the vast array of web sites dedicated to language learning enabling students, either autonomously or in a CALL classroom, to study English via movie commercials. To assist students in comprehending 10 trailers found on the site, the authors created the Short Readings…

  5. Effects of an Informational Text Reading Comprehension Intervention for Fifth-Grade Students

    Science.gov (United States)

    Ritchey, Kristen D.; Palombo, Kimberly; Silverman, Rebecca D.; Speece, Deborah L.

    2017-01-01

    Upper elementary school students who have reading problems may have difficulty in one or more areas of reading, each requiring specific types of interventions. This study evaluated a short-term reading intervention for 46 fifth-grade students with poor reading comprehension. Students were randomly assigned to an intervention or no treatment…

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

  7. Phonological skills and their role in learning to read: a meta-analytic review.

    Science.gov (United States)

    Melby-Lervåg, Monica; Lyster, Solveig-Alma Halaas; Hulme, Charles

    2012-03-01

    The authors report a systematic meta-analytic review of the relationships among 3 of the most widely studied measures of children's phonological skills (phonemic awareness, rime awareness, and verbal short-term memory) and children's word reading skills. The review included both extreme group studies and correlational studies with unselected samples (235 studies were included, and 995 effect sizes were calculated). Results from extreme group comparisons indicated that children with dyslexia show a large deficit on phonemic awareness in relation to typically developing children of the same age (pooled effect size estimate: -1.37) and children matched on reading level (pooled effect size estimate: -0.57). There were significantly smaller group deficits on both rime awareness and verbal short-term memory (pooled effect size estimates: rime skills in relation to age-matched controls, -0.93, and reading-level controls, -0.37; verbal short-term memory skills in relation to age-matched controls, -0.71, and reading-level controls, -0.09). Analyses of studies of unselected samples showed that phonemic awareness was the strongest correlate of individual differences in word reading ability and that this effect remained reliable after controlling for variations in both verbal short-term memory and rime awareness. These findings support the pivotal role of phonemic awareness as a predictor of individual differences in reading development. We discuss whether such a relationship is a causal one and the implications of research in this area for current approaches to the teaching of reading and interventions for children with reading difficulties.

  8. L2 Working Memory Capacity and L2 Reading Skill.

    Science.gov (United States)

    Harrington, Mike; Sawyer, Mark

    1992-01-01

    Examines the sensitivity of second-language (L2) working memory (ability to store and process information simultaneously) to differences in reading skills among advanced L2 learners. Subjects with larger L2 working memory capacities scored higher on measures of L2 reading skills, but no correlation was found between reading and passive short-term…

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

  10. Just reading: increasing pace and volume of reading whole narratives on the comprehension of poorer adolescent readers in English classrooms

    OpenAIRE

    Westbrook, Jo; Sutherland, Julia; Oakhill, Jane; Sullivan, Susan

    2018-01-01

    Poorer adolescent readers are often regarded by teachers as unable to read whole narratives and given short, simplified texts, yet are expected to analyse every part in a slow laborious read through. This article reports on a mixed methods study in which 20 English teachers in the South of England changed their current practice to read two whole challenging novels at a faster pace than usual in 12 weeks with their average and poorer readers ages 12-13. Ten teachers received additional trainin...

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

  12. Backbiting and bloodshed in books: short-term effects of reading physical and relational aggression in literature.

    Science.gov (United States)

    Coyne, Sarah M; Ridge, Robert; Stevens, McKay; Callister, Mark; Stockdale, Laura

    2012-03-01

    The current research consisted of two studies examining the effects of reading physical and relational aggression in literature. In both studies, participants read one of two stories (containing physical or relational aggression), and then participated in one of two tasks to measure aggression. In Study 1, participants who read the physical aggression story were subsequently more physically aggressive than those who read the relational aggression story. Conversely, in Study 2, participants who read the relational aggression story were subsequently more relationally aggressive than those who read the physical aggression story. Combined, these results show evidence for specific effects of reading aggressive content in literature. © 2011 The British Psychological Society.

  13. Visual processing in reading disorders and attention-deficit/hyperactivity disorder and its contribution to basic reading ability

    Directory of Open Access Journals (Sweden)

    Michelle Y. Kibby

    2015-10-01

    Full Text Available Whether visual processing deficits are common in reading disorders (RD, and related to reading ability in general, has been debated for decades. The type of visual processing affected also is debated, although visual discrimination and short-term memory (STM may be more commonly related to reading ability. Reading disorders are frequently comorbid with ADHD, and children with ADHD often have subclinical reading problems. Hence, children with ADHD were used as a comparison group in this study. ADHD and RD may be dissociated in terms of visual processing. Whereas RD may be associated with deficits in visual discrimination and short-term memory for order, ADHD is associated with deficits in visual-spatial processing. Thus, we hypothesized that children with RD would perform worse than controls and children with ADHD only on a measure of visual discrimination and a measure of visual STM that requires memory for order. We expected all groups would perform comparably on the measure of visual STM that does not require sequential processing. We found children with RD or ADHD were commensurate to controls on measures of visual discrimination and visual STM that do not require sequential processing. In contrast, both RD groups (RD, RD/ADHD performed worse than controls on the measure of visual STM that requires memory for order, and children with comorbid RD/ADHD performed worse than those with ADHD. In addition, of the three visual measures, only sequential visual STM predicted reading ability. Hence, our findings suggest there is a deficit in visual sequential STM that is specific to RD and is related to basic reading ability. The source of this deficit is worthy of further research, but it may include both reduced memory for order and poorer verbal mediation.

  14. Identifying structural variants using linked-read sequencing data.

    Science.gov (United States)

    Elyanow, Rebecca; Wu, Hsin-Ta; Raphael, Benjamin J

    2017-11-03

    Structural variation, including large deletions, duplications, inversions, translocations, and other rearrangements, is common in human and cancer genomes. A number of methods have been developed to identify structural variants from Illumina short-read sequencing data. However, reliable identification of structural variants remains challenging because many variants have breakpoints in repetitive regions of the genome and thus are difficult to identify with short reads. The recently developed linked-read sequencing technology from 10X Genomics combines a novel barcoding strategy with Illumina sequencing. This technology labels all reads that originate from a small number (~5-10) DNA molecules ~50Kbp in length with the same molecular barcode. These barcoded reads contain long-range sequence information that is advantageous for identification of structural variants. We present Novel Adjacency Identification with Barcoded Reads (NAIBR), an algorithm to identify structural variants in linked-read sequencing data. NAIBR predicts novel adjacencies in a individual genome resulting from structural variants using a probabilistic model that combines multiple signals in barcoded reads. We show that NAIBR outperforms several existing methods for structural variant identification - including two recent methods that also analyze linked-reads - on simulated sequencing data and 10X whole-genome sequencing data from the NA12878 human genome and the HCC1954 breast cancer cell line. Several of the novel somatic structural variants identified in HCC1954 overlap known cancer genes. Software is available at compbio.cs.brown.edu/software. braphael@princeton.edu. 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. 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.

  16. Correlates of Early Reading Comprehension Skills: A Componential Analysis

    Science.gov (United States)

    Babayigit, Selma; Stainthorp, Rhona

    2014-01-01

    This study had three main aims. First, we examined to what extent listening comprehension, vocabulary, grammatical skills and verbal short-term memory (VSTM) assessed prior to formal reading instruction explained individual differences in early reading comprehension levels. Second, we examined to what extent the three common component skills,…

  17. Reading speed, comprehension and eye movements while reading Japanese novels: evidence from untrained readers and cases of speed-reading trainees.

    Directory of Open Access Journals (Sweden)

    Hiromitsu Miyata

    Full Text Available BACKGROUND: A growing body of evidence suggests that meditative training enhances perception and cognition. In Japan, the Park-Sasaki method of speed-reading involves organized visual training while forming both a relaxed and concentrated state of mind, as in meditation. The present study examined relationships between reading speed, sentence comprehension, and eye movements while reading short Japanese novels. In addition to normal untrained readers, three middle-level trainees and one high-level expert on this method were included for the two case studies. METHODOLOGY/PRINCIPAL FINDINGS: In Study 1, three of 17 participants were middle-level trainees on the speed-reading method. Immediately after reading each story once on a computer monitor, participants answered true or false questions regarding the content of the novel. Eye movements while reading were recorded using an eye-tracking system. Results revealed higher reading speed and lower comprehension scores in the trainees than in the untrained participants. Furthermore, eye-tracking data by untrained participants revealed multiple correlations between reading speed, accuracy and eye-movement measures, with faster readers showing shorter fixation durations and larger saccades in X than slower readers. In Study 2, participants included a high-level expert and 14 untrained students. The expert showed higher reading speed and statistically comparable, although numerically lower, comprehension scores compared with the untrained participants. During test sessions this expert moved her eyes along a nearly straight horizontal line as a first pass, without moving her eyes over the whole sentence display as did the untrained students. CONCLUSIONS/SIGNIFICANCE: In addition to revealing correlations between speed, comprehension and eye movements in reading Japanese contemporary novels by untrained readers, we describe cases of speed-reading trainees regarding relationships between these variables

  18. De novo assembly of a 40 Mb eukaryotic genome from short sequence reads: Sordaria macrospora, a model organism for fungal morphogenesis.

    Science.gov (United States)

    Nowrousian, Minou; Stajich, Jason E; Chu, Meiling; Engh, Ines; Espagne, Eric; Halliday, Karen; Kamerewerd, Jens; Kempken, Frank; Knab, Birgit; Kuo, Hsiao-Che; Osiewacz, Heinz D; Pöggeler, Stefanie; Read, Nick D; Seiler, Stephan; Smith, Kristina M; Zickler, Denise; Kück, Ulrich; Freitag, Michael

    2010-04-08

    Filamentous fungi are of great importance in ecology, agriculture, medicine, and biotechnology. Thus, it is not surprising that genomes for more than 100 filamentous fungi have been sequenced, most of them by Sanger sequencing. While next-generation sequencing techniques have revolutionized genome resequencing, e.g. for strain comparisons, genetic mapping, or transcriptome and ChIP analyses, de novo assembly of eukaryotic genomes still presents significant hurdles, because of their large size and stretches of repetitive sequences. Filamentous fungi contain few repetitive regions in their 30-90 Mb genomes and thus are suitable candidates to test de novo genome assembly from short sequence reads. Here, we present a high-quality draft sequence of the Sordaria macrospora genome that was obtained by a combination of Illumina/Solexa and Roche/454 sequencing. Paired-end Solexa sequencing of genomic DNA to 85-fold coverage and an additional 10-fold coverage by single-end 454 sequencing resulted in approximately 4 Gb of DNA sequence. Reads were assembled to a 40 Mb draft version (N50 of 117 kb) with the Velvet assembler. Comparative analysis with Neurospora genomes increased the N50 to 498 kb. The S. macrospora genome contains even fewer repeat regions than its closest sequenced relative, Neurospora crassa. Comparison with genomes of other fungi showed that S. macrospora, a model organism for morphogenesis and meiosis, harbors duplications of several genes involved in self/nonself-recognition. Furthermore, S. macrospora contains more polyketide biosynthesis genes than N. crassa. Phylogenetic analyses suggest that some of these genes may have been acquired by horizontal gene transfer from a distantly related ascomycete group. Our study shows that, for typical filamentous fungi, de novo assembly of genomes from short sequence reads alone is feasible, that a mixture of Solexa and 454 sequencing substantially improves the assembly, and that the resulting data can be used for

  19. De novo assembly of a 40 Mb eukaryotic genome from short sequence reads: Sordaria macrospora, a model organism for fungal morphogenesis.

    Directory of Open Access Journals (Sweden)

    Minou Nowrousian

    2010-04-01

    Full Text Available Filamentous fungi are of great importance in ecology, agriculture, medicine, and biotechnology. Thus, it is not surprising that genomes for more than 100 filamentous fungi have been sequenced, most of them by Sanger sequencing. While next-generation sequencing techniques have revolutionized genome resequencing, e.g. for strain comparisons, genetic mapping, or transcriptome and ChIP analyses, de novo assembly of eukaryotic genomes still presents significant hurdles, because of their large size and stretches of repetitive sequences. Filamentous fungi contain few repetitive regions in their 30-90 Mb genomes and thus are suitable candidates to test de novo genome assembly from short sequence reads. Here, we present a high-quality draft sequence of the Sordaria macrospora genome that was obtained by a combination of Illumina/Solexa and Roche/454 sequencing. Paired-end Solexa sequencing of genomic DNA to 85-fold coverage and an additional 10-fold coverage by single-end 454 sequencing resulted in approximately 4 Gb of DNA sequence. Reads were assembled to a 40 Mb draft version (N50 of 117 kb with the Velvet assembler. Comparative analysis with Neurospora genomes increased the N50 to 498 kb. The S. macrospora genome contains even fewer repeat regions than its closest sequenced relative, Neurospora crassa. Comparison with genomes of other fungi showed that S. macrospora, a model organism for morphogenesis and meiosis, harbors duplications of several genes involved in self/nonself-recognition. Furthermore, S. macrospora contains more polyketide biosynthesis genes than N. crassa. Phylogenetic analyses suggest that some of these genes may have been acquired by horizontal gene transfer from a distantly related ascomycete group. Our study shows that, for typical filamentous fungi, de novo assembly of genomes from short sequence reads alone is feasible, that a mixture of Solexa and 454 sequencing substantially improves the assembly, and that the resulting data

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

  1. Short Historical Fiction To Get Children Reading.

    Science.gov (United States)

    Sullivan, Kathleen

    1997-01-01

    Provides an annotated bibliography of short historical fiction and picture books for readers in grades K-8. Includes a list of selected Caldecott and Newbery winners with historical themes or backgrounds and a list of activity books featuring Spanish exploration in Mexico, Roman art and fashion, medieval Europe, and cowboys. (PEN)

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

  3. Age-related changes in crowding and reading speed

    OpenAIRE

    Liu, Rong; Patel, Bhavika N.; Kwon, MiYoung

    2017-01-01

    Crowding, the inability to recognize objects in clutter, is known to play a role in developmental changes in reading speed. Here, we investigated whether crowding also plays a role in age-related changes in reading speed. We recruited 18 young (mean age: 22.6???3.5; range: 18~31) and 21 older adults (mean age: 58.2???7.0; range: 50~73) with normal vision. Reading speed was measured with short blocks of text. The degree of crowding was determined by measuring crowding zone (the distance betwee...

  4. readShape

    International Nuclear Information System (INIS)

    Zitniak, J.; Pargac, M.

    2005-01-01

    In the Slovak Environmental Agency during relative short time originated the first version of software product using of GPS technology for monitoring of negative phenomena in nature. It was denominated as readShape and its primary goal is to minister for conservator of environment geographically strictly to observe endangered territories as are, for example, fire, fish kill, impact of motor vehicle accident or dangerous objects as are illegal stock-piles, wastes and other. Process of monitoring is described

  5. Efficient Learning for the Poor: New Insights into Literacy Acquisition for Children

    Science.gov (United States)

    Abadzi, Helen

    2008-01-01

    Reading depends on the speed of visual recognition and capacity of short-term memory. To understand a sentence, the mind must read it fast enough to capture it within the limits of the short-term memory. This means that children must attain a minimum speed of fairly accurate reading to understand a passage. Learning to read involves "tricking" the…

  6. Perspective Effects during Reading: Evidence from Text Change-Detection

    Science.gov (United States)

    Bohan, Jason; Filik, Ruth

    2018-01-01

    We report two text change-detection studies in which we investigate the influence of reading perspective on text memory. In Experiment 1 participants read from the perspective of one of two characters in a series of short stories, and word changes were either semantically close or distant. Participants correctly reported more changes to…

  7. Prosodic Similarity Effects in Short-Term Memory in Developmental Dyslexia.

    Science.gov (United States)

    Goswami, Usha; Barnes, Lisa; Mead, Natasha; Power, Alan James; Leong, Victoria

    2016-11-01

    Children with developmental dyslexia are characterized by phonological difficulties across languages. Classically, this 'phonological deficit' in dyslexia has been investigated with tasks using single-syllable words. Recently, however, several studies have demonstrated difficulties in prosodic awareness in dyslexia. Potential prosodic effects in short-term memory have not yet been investigated. Here we create a new instrument based on three-syllable words that vary in stress patterns, to investigate whether prosodic similarity (the same prosodic pattern of stressed and unstressed syllables) exerts systematic effects on short-term memory. We study participants with dyslexia and age-matched and younger reading-level-matched typically developing controls. We find that all participants, including dyslexic participants, show prosodic similarity effects in short-term memory. All participants exhibited better retention of words that differed in prosodic structure, although participants with dyslexia recalled fewer words accurately overall compared to age-matched controls. Individual differences in prosodic memory were predicted by earlier vocabulary abilities, by earlier sensitivity to syllable stress and by earlier phonological awareness. To our knowledge, this is the first demonstration of prosodic similarity effects in short-term memory. The implications of a prosodic similarity effect for theories of lexical representation and of dyslexia are discussed. © 2016 The Authors. Dyslexia published by John Wiley & Sons Ltd. © 2016 The Authors. Dyslexia published by John Wiley & Sons Ltd.

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

  9. Genetic covariance structure of reading, intelligence and memory in children

    NARCIS (Netherlands)

    van Leeuwen, Marieke; van den Berg, Stéphanie Martine; Peper, Jiska S.; Hulshoff Pol, Hilleke E.; Boomsma, Dorret I.

    2009-01-01

    This study investigates the genetic relationship among reading performance, IQ, verbal and visuospatial working memory (WM) and short-term memory (STM) in a sample of 112, 9-year-old twin pairs and their older siblings. The relationship between reading performance and the other traits was explained

  10. Genetic Covariance Structure of Reading, Intelligence and Memory in Children

    NARCIS (Netherlands)

    van Leeuwen, M.; van den Berg, S.M.; Peper, J.S.; Hulshoff Pol, H.E.; Boomsma, D.I.

    2009-01-01

    This study investigates the genetic relationship among reading performance, IQ, verbal and visuospatial working memory (WM) and short-term memory (STM) in a sample of 112, 9-year-old twin pairs and their older siblings. The relationship between reading performance and the other traits was explained

  11. Genetic Covariance Structure of Reading, Intelligence and Memory in Children

    NARCIS (Netherlands)

    van Leeuwen, Marieke; van den Berg, Stephanie M.; Peper, Jiska S.; Pol, Hilleke E. Hulshoff; Boomsma, Dorret I.

    This study investigates the genetic relationship among reading performance, IQ, verbal and visuospatial working memory (WM) and short-term memory (STM) in a sample of 112, 9-year-old twin pairs and their older siblings. The relationship between reading performance and the other traits was explained

  12. Toward developing a standardized Arabic continuous text reading chart.

    Science.gov (United States)

    Alabdulkader, Balsam; Leat, Susan Jennifer

    Near visual acuity is an essential measurement during an oculo-visual assessment. Short duration continuous text reading charts measure reading acuity and other aspects of reading performance. There is no standardized version of such chart in Arabic. The aim of this study is to create sentences of equal readability to use in the development of a standardized Arabic continuous text reading chart. Initially, 109 Arabic pairs of sentences were created for use in constructing a chart with similar layout to the Colenbrander chart. They were created to have the same grade level of difficulty and physical length. Fifty-three adults and sixteen children were recruited to validate the sentences. Reading speed in correct words per minute (CWPM) and standard length words per minute (SLWPM) was measured and errors were counted. Criteria based on reading speed and errors made in each sentence pair were used to exclude sentence pairs with more outlying characteristics, and to select the final group of sentence pairs. Forty-five sentence pairs were selected according to the elimination criteria. For adults, the average reading speed for the final sentences was 166 CWPM and 187 SLWPM and the average number of errors per sentence pair was 0.21. Childrens' average reading speed for the final group of sentences was 61 CWPM and 72 SLWPM. Their average error rate was 1.71. The reliability analysis showed that the final 45 sentence pairs are highly comparable. They will be used in constructing an Arabic short duration continuous text reading chart. Copyright © 2016 Spanish General Council of Optometry. Published by Elsevier España, S.L.U. All rights reserved.

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

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

  15. Supporting read-across using biological data.

    Science.gov (United States)

    Zhu, Hao; Bouhifd, Mounir; Donley, Elizabeth; Egnash, Laura; Kleinstreuer, Nicole; Kroese, E Dinant; Liu, Zhichao; Luechtefeld, Thomas; Palmer, Jessica; Pamies, David; Shen, Jie; Strauss, Volker; Wu, Shengde; Hartung, Thomas

    2016-01-01

    Read-across, i.e. filling toxicological data gaps by relating to similar chemicals, for which test data are available, is usually done based on chemical similarity. Besides structure and physico-chemical properties, however, biological similarity based on biological data adds extra strength to this process. In the context of developing Good Read-Across Practice guidance, a number of case studies were evaluated to demonstrate the use of biological data to enrich read-across. In the simplest case, chemically similar substances also show similar test results in relevant in vitro assays. This is a well-established method for the read-across of e.g. genotoxicity assays. Larger datasets of biological and toxicological properties of hundreds and thousands of substances become increasingly available enabling big data approaches in read-across studies. Several case studies using various big data sources are described in this paper. An example is given for the US EPA's ToxCast dataset allowing read-across for high quality uterotrophic assays for estrogenic endocrine disruption. Similarly, an example for REACH registration data enhancing read-across for acute toxicity studies is given. A different approach is taken using omics data to establish biological similarity: Examples are given for stem cell models in vitro and short-term repeated dose studies in rats in vivo to support read-across and category formation. These preliminary biological data-driven read-across studies highlight the road to the new generation of read-across approaches that can be applied in chemical safety assessment.

  16. Reading visual braille with a retinal prosthesis.

    Science.gov (United States)

    Lauritzen, Thomas Z; Harris, Jordan; Mohand-Said, Saddek; Sahel, Jose A; Dorn, Jessy D; McClure, Kelly; Greenberg, Robert J

    2012-01-01

    Retinal prostheses, which restore partial vision to patients blinded by outer retinal degeneration, are currently in clinical trial. The Argus II retinal prosthesis system was recently awarded CE approval for commercial use in Europe. While retinal prosthesis users have achieved remarkable visual improvement to the point of reading letters and short sentences, the reading process is still fairly cumbersome. This study investigates the possibility of using an epiretinal prosthesis to stimulate visual braille as a sensory substitution for reading written letters and words. The Argus II retinal prosthesis system, used in this study, includes a 10 × 6 electrode array implanted epiretinally, a tiny video camera mounted on a pair of glasses, and a wearable computer that processes the video and determines the stimulation current of each electrode in real time. In the braille reading system, individual letters are created by a subset of dots from a 3 by 2 array of six dots. For the visual braille experiment, a grid of six electrodes was chosen out of the 10 × 6 Argus II array. Groups of these electrodes were then directly stimulated (bypassing the camera) to create visual percepts of individual braille letters. Experiments were performed in a single subject. Single letters were stimulated in an alternative forced choice (AFC) paradigm, and short 2-4-letter words were stimulated (one letter at a time) in an open-choice reading paradigm. The subject correctly identified 89% of single letters, 80% of 2-letter, 60% of 3-letter, and 70% of 4-letter words. This work suggests that text can successfully be stimulated and read as visual braille in retinal prosthesis patients.

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

  18. Troubled reading: ‘Sonny’s blues’ and empathy

    Directory of Open Access Journals (Sweden)

    Eva Kowalska

    2015-07-01

    Full Text Available This article uses a discussion of Baldwin’s short story ‘Sonny’s blues’ as a means of exploring reading and approaches to drug literature. It considers the possibility of understanding Baldwin’s fictional text as a statement on reading social as well as subjective ‘problems’ as universal across contexts. Using conclusions gleaned from a detailed reading of the primary text, as well as the contributions of others to the field, it argues for the importance of reading, as audience and as scholars, with the capacity to allow for the transformation of problematic subjective experience such as drug addiction into artistic expression with value beyond its initial context.

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

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

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

  2. Language differences in the brain network for reading in naturalistic story reading and lexical decision.

    Science.gov (United States)

    Wang, Xiaojuan; Yang, Jianfeng; Yang, Jie; Mencl, W Einar; Shu, Hua; Zevin, Jason David

    2015-01-01

    Differences in how writing systems represent language raise important questions about whether there could be a universal functional architecture for reading across languages. In order to study potential language differences in the neural networks that support reading skill, we collected fMRI data from readers of alphabetic (English) and morpho-syllabic (Chinese) writing systems during two reading tasks. In one, participants read short stories under conditions that approximate natural reading, and in the other, participants decided whether individual stimuli were real words or not. Prior work comparing these two writing systems has overwhelmingly used meta-linguistic tasks, generally supporting the conclusion that the reading system is organized differently for skilled readers of Chinese and English. We observed that language differences in the reading network were greatly dependent on task. In lexical decision, a pattern consistent with prior research was observed in which the Middle Frontal Gyrus (MFG) and right Fusiform Gyrus (rFFG) were more active for Chinese than for English, whereas the posterior temporal sulcus was more active for English than for Chinese. We found a very different pattern of language effects in a naturalistic reading paradigm, during which significant differences were only observed in visual regions not typically considered specific to the reading network, and the middle temporal gyrus, which is thought to be important for direct mapping of orthography to semantics. Indeed, in areas that are often discussed as supporting distinct cognitive or linguistic functions between the two languages, we observed interaction. Specifically, language differences were most pronounced in MFG and rFFG during the lexical decision task, whereas no language differences were observed in these areas during silent reading of text for comprehension.

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

  4. Processing Determinants of Reading Speed.

    Science.gov (United States)

    Jackson, Mark D.; McClelland, James L.

    1979-01-01

    Two groups of undergraduates differing in reading ability were tested on a number of reaction-time tasks designed to determine the speed of encoding visual information at several different levels, tests of sensory functions, verbal and quantitative reasoning ability, short-term auditory memory span, and ability to comprehend spoken text.…

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

  6. Highly Accurate Prediction of Jobs Runtime Classes

    OpenAIRE

    Reiner-Benaim, Anat; Grabarnick, Anna; Shmueli, Edi

    2016-01-01

    Separating the short jobs from the long is a known technique to improve scheduling performance. In this paper we describe a method we developed for accurately predicting the runtimes classes of the jobs to enable this separation. Our method uses the fact that the runtimes can be represented as a mixture of overlapping Gaussian distributions, in order to train a CART classifier to provide the prediction. The threshold that separates the short jobs from the long jobs is determined during the ev...

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

  8. Verbal and visuospatial working memory as predictors of children's reading ability.

    Science.gov (United States)

    Pham, Andy V; Hasson, Ramzi M

    2014-08-01

    Children with reading difficulties often demonstrate weaknesses in working memory (WM). This research study explored the relation between two WM systems (verbal and visuospatial WM) and reading ability in a sample of school-aged children with a wide range of reading skills. Children (N = 157), ages 9-12, were administered measures of short-term memory, verbal WM, visuospatial WM, and reading measures (e.g., reading fluency and comprehension). Although results indicated that verbal WM was a stronger predictor in reading fluency and comprehension, visuospatial WM also significantly predicted reading skills, but provided more unique variance in reading comprehension than reading fluency. These findings suggest that visuospatial WM may play a significant role in higher level reading processes, particularly in reading comprehension, than previously thought. © The Author 2014. Published by Oxford University Press. All rights reserved. For permissions, please e-mail: journals.permissions@oup.com.

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

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

  11. Language differences in the brain network for reading in naturalistic story reading and lexical decision.

    Directory of Open Access Journals (Sweden)

    Xiaojuan Wang

    Full Text Available Differences in how writing systems represent language raise important questions about whether there could be a universal functional architecture for reading across languages. In order to study potential language differences in the neural networks that support reading skill, we collected fMRI data from readers of alphabetic (English and morpho-syllabic (Chinese writing systems during two reading tasks. In one, participants read short stories under conditions that approximate natural reading, and in the other, participants decided whether individual stimuli were real words or not. Prior work comparing these two writing systems has overwhelmingly used meta-linguistic tasks, generally supporting the conclusion that the reading system is organized differently for skilled readers of Chinese and English. We observed that language differences in the reading network were greatly dependent on task. In lexical decision, a pattern consistent with prior research was observed in which the Middle Frontal Gyrus (MFG and right Fusiform Gyrus (rFFG were more active for Chinese than for English, whereas the posterior temporal sulcus was more active for English than for Chinese. We found a very different pattern of language effects in a naturalistic reading paradigm, during which significant differences were only observed in visual regions not typically considered specific to the reading network, and the middle temporal gyrus, which is thought to be important for direct mapping of orthography to semantics. Indeed, in areas that are often discussed as supporting distinct cognitive or linguistic functions between the two languages, we observed interaction. Specifically, language differences were most pronounced in MFG and rFFG during the lexical decision task, whereas no language differences were observed in these areas during silent reading of text for comprehension.

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

  13. LRSim: A Linked-Reads Simulator Generating Insights for Better Genome Partitioning

    Directory of Open Access Journals (Sweden)

    Ruibang Luo

    Full Text Available Linked-read sequencing, using highly-multiplexed genome partitioning and barcoding, can span hundreds of kilobases to improve de novo assembly, haplotype phasing, and other applications. Based on our analysis of 14 datasets, we introduce LRSim that simulates linked-reads by emulating the library preparation and sequencing process with fine control over variants, linked-read characteristics, and the short-read profile. We conclude from the phasing and assembly of multiple datasets, recommendations on coverage, fragment length, and partitioning when sequencing genomes of different sizes and complexities. These optimizations improve results by orders of magnitude, and enable the development of novel methods. LRSim is available at https://github.com/aquaskyline/LRSIM. Keywords: Linked-read, Molecular barcoding, Reads partitioning, Phasing, Reads simulation, Genome assembly, 10X Genomics

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

  15. Accurate mass measurements of short-lived isotopes with the MISTRAL rf spectrometer

    CERN Document Server

    Toader, C F; Borcea, C; Doubre, H; Duma, M; Jacotin, M; Henry, S; Képinski, J F; Lebée, G; Le Scornet, G; Lunney, M D; Monsanglant, C; De Saint-Simon, M; Thibault, C

    1999-01-01

    The MISTRAL experiment has measured its first masses at ISOLDE. Installed in May 1997, this radiofrequency transmission spectrometer is to concentrate on nuclides with particularly short half-lives. MISTRAL received its first stable beam in October and first radioactive beam in November 1997. These first tests, with a plasma ion source, resulted in excellent isobaric separation and reasonable transmission. Further testing and development enabled first data taking in July 1998 on neutron-rich Na isotopes having half-lives as short as 31 ms.

  16. Reading the Writer's Craft: The Hemingway Short Stories

    Science.gov (United States)

    Garrigues, Lisa

    2004-01-01

    The high school students who spent five weeks studying the style and craft of Ernest Hemingway experienced the power and plus points of apprenticeships. Several assignments that helped the high school juniors to analyze Hemingway's work on short stories and learn from this master craftsman are presented.

  17. Assembly of Repeat Content Using Next Generation Sequencing Data

    Energy Technology Data Exchange (ETDEWEB)

    labutti, Kurt; Kuo, Alan; Grigoriev, Igor; Copeland, Alex

    2014-03-17

    Repetitive organisms pose a challenge for short read assembly, and typically only unique regions and repeat regions shorter than the read length, can be accurately assembled. Recently, we have been investigating the use of Pacific Biosciences reads for de novo fungal assembly. We will present an assessment of the quality and degree of repeat reconstruction possible in a fungal genome using long read technology. We will also compare differences in assembly of repeat content using short read and long read technology.

  18. Discourse Memory and Reading Comprehension Skill

    Science.gov (United States)

    Perfetti, Charles A.; Goldman, Susan R.

    1976-01-01

    A study is reported in which short-term memory capacity, estimated by a probe digit task, and memory for structured language, measured by a probe discourse task, were investigated in an experiment with third and fifth grade IQ-matched children representing two levels of reading comprehension skill. (Author/RM)

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

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

  1. Effects of audio-visual aids on foreign language test anxiety, reading and listening comprehension, and retention in EFL learners.

    Science.gov (United States)

    Lee, Shu-Ping; Lee, Shin-Da; Liao, Yuan-Lin; Wang, An-Chi

    2015-04-01

    This study examined the effects of audio-visual aids on anxiety, comprehension test scores, and retention in reading and listening to short stories in English as a Foreign Language (EFL) classrooms. Reading and listening tests, general and test anxiety, and retention were measured in English-major college students in an experimental group with audio-visual aids (n=83) and a control group without audio-visual aids (n=94) with similar general English proficiency. Lower reading test anxiety, unchanged reading comprehension scores, and better reading short-term and long-term retention after four weeks were evident in the audiovisual group relative to the control group. In addition, lower listening test anxiety, higher listening comprehension scores, and unchanged short-term and long-term retention were found in the audiovisual group relative to the control group after the intervention. Audio-visual aids may help to reduce EFL learners' listening test anxiety and enhance their listening comprehension scores without facilitating retention of such materials. Although audio-visual aids did not increase reading comprehension scores, they helped reduce EFL learners' reading test anxiety and facilitated retention of reading materials.

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

  3. De Novo Assembly of Human Herpes Virus Type 1 (HHV-1) Genome, Mining of Non-Canonical Structures and Detection of Novel Drug-Resistance Mutations Using Short- and Long-Read Next Generation Sequencing Technologies.

    Science.gov (United States)

    Karamitros, Timokratis; Harrison, Ian; Piorkowska, Renata; Katzourakis, Aris; Magiorkinis, Gkikas; Mbisa, Jean Lutamyo

    2016-01-01

    Human herpesvirus type 1 (HHV-1) has a large double-stranded DNA genome of approximately 152 kbp that is structurally complex and GC-rich. This makes the assembly of HHV-1 whole genomes from short-read sequencing data technically challenging. To improve the assembly of HHV-1 genomes we have employed a hybrid genome assembly protocol using data from two sequencing technologies: the short-read Roche 454 and the long-read Oxford Nanopore MinION sequencers. We sequenced 18 HHV-1 cell culture-isolated clinical specimens collected from immunocompromised patients undergoing antiviral therapy. The susceptibility of the samples to several antivirals was determined by plaque reduction assay. Hybrid genome assembly resulted in a decrease in the number of contigs in 6 out of 7 samples and an increase in N(G)50 and N(G)75 of all 7 samples sequenced by both technologies. The approach also enhanced the detection of non-canonical contigs including a rearrangement between the unique (UL) and repeat (T/IRL) sequence regions of one sample that was not detectable by assembly of 454 reads alone. We detected several known and novel resistance-associated mutations in UL23 and UL30 genes. Genome-wide genetic variability ranged from genomes will be useful in determining genetic determinants of drug resistance, virulence, pathogenesis and viral evolution. The numerous, complex repeat regions of the HHV-1 genome currently remain a barrier towards this goal.

  4. Reading Parallel Texts in the Target Language: A Way to Improve Literary Translation Quality

    Directory of Open Access Journals (Sweden)

    Nazanin Shadman

    2013-10-01

    Full Text Available The present study was an attempt to investigate the effect of reading Persian literary texts on the quality of literary translations. To this end, 52 students majoring in English translation were randomly assigned to two groups. A Comprehensive English Language Test (CELT was administered to check the homogeneity of the participants. The treatment for the experimental group consisted of reading 60 Persian short stories and poems. In the meantime, the control group went through their ordinary course curriculum. Both groups were asked to translate extracts of two short stories. The translations were then rated. Through statistical analysis, it was revealed that reading Persian literary works, indeed, improves the quality of literary translations. Therefore, to promote a more fruitful instruction on literary translation, it is suggested that translation teachers attempt to consider reading Persian literary works as part of the curriculum and ask students to read Persian texts to the extent possible, so that more qualified translations would be rendered in the area of literature.

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

  6. Experimental Study on RFID Antenna Reading Areas in a Tunnel System

    Directory of Open Access Journals (Sweden)

    Kai Kordelin

    2017-01-01

    Full Text Available We study optimized antenna reading area mappings for a radiofrequency identification- (RFID- based access monitoring system, used in an underground nuclear waste storage facility. We shortly introduce the access monitoring system developed for the ONKALO tunnel in Finland and describe the antenna mounting points as well as the research area. Finally, we study the measurement results of the antenna reading areas and factors that affect the reading area size. Based on our results, in addition to antenna location and direction, absorption to obstacles, reflections, diffraction, scattering, and refraction affect the antenna reading area.

  7. Shorter lines facilitate reading in those who struggle.

    Directory of Open Access Journals (Sweden)

    Matthew H Schneps

    Full Text Available People with dyslexia, who ordinarily struggle to read, sometimes remark that reading is easier when e-readers are used. Here, we used eye tracking to observe high school students with dyslexia as they read using these devices. Among the factors investigated, we found that reading using a small device resulted in substantial benefits, improving reading speeds by 27%, reducing the number of fixations by 11%, and importantly, reducing the number of regressive saccades by more than a factor of 2, with no cost to comprehension. Given that an expected trade-off between horizontal and vertical regression was not observed when line lengths were altered, we speculate that these effects occur because sluggish attention spreads perception to the left as the gaze shifts during reading. Short lines eliminate crowded text to the left, reducing regression. The effects of attention modulation by the hand, and of increased letter spacing to reduce crowding, were also found to modulate the oculomotor dynamics in reading, but whether these factors resulted in benefits or costs depended on characteristics, such as visual attention span, that varied within our sample.

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

  9. Minor Immediate Effects of a Dog on Children’s Reading Performance and Physiology

    Directory of Open Access Journals (Sweden)

    Lisa Schretzmayer

    2017-06-01

    Full Text Available Literacy is a key factor in occupational success and social integration. However, an increasing number of children lack appropriate reading skills. There is growing evidence that dogs have positive effects on reading performance. We investigated the short-term effects of dogs on reading performance in 36 third-graders and monitored physiological parameters [heart rate (HR, heart rate variability (HRV, and salivary cortisol] as well as behavioral variables. Each child took part in two test sessions at the presence of a tutor, in one of which a dog and its handler were present. To assess reading performance two reading tests were used: two subtests of the standardized “Ein Leseverständnistest für Erst- bis Sechstklässler”, where the children have to carry out time-limited reading tasks, to assess sentence and text comprehension, and repeated reading (RR, where the children have to read the same text twice, to assess reading speed and short-term improvement. Although the dog had no effect on reading performance scores, within the first test session the children improved from the first to the second run of RR when a dog was present but not without dog. The behavior of the children indicated a calming effect of the dog in the first test session with less nervous movements and the children being less talkative. We found no impact of the dog on HR and HRV. However, the excitement about the dog in combination with the unknown situation in the first test session was reflected in a higher difference in the mean HR difference between the two test sessions for the children, who in the first test session had a dog present, compared to the children, who had the dog in the second test session. In the second test session, the children were more aroused with a dog present than with no dog present, as indicated by the area under the curve increase (AUCi of salivary cortisol values. We conclude that the presence of a dog had a minor short-term positive

  10. Using Serial and Discrete Digit Naming to Unravel Word Reading Processes.

    Science.gov (United States)

    Altani, Angeliki; Protopapas, Athanassios; Georgiou, George K

    2018-01-01

    During reading acquisition, word recognition is assumed to undergo a developmental shift from slow serial/sublexical processing of letter strings to fast parallel processing of whole word forms. This shift has been proposed to be detected by examining the size of the relationship between serial- and discrete-trial versions of word reading and rapid naming tasks. Specifically, a strong association between serial naming of symbols and single word reading suggests that words are processed serially, whereas a strong association between discrete naming of symbols and single word reading suggests that words are processed in parallel as wholes. In this study, 429 Grade 1, 3, and 5 English-speaking Canadian children were tested on serial and discrete digit naming and word reading. Across grades, single word reading was more strongly associated with discrete naming than with serial naming of digits, indicating that short high-frequency words are processed as whole units early in the development of reading ability in English. In contrast, serial naming was not a unique predictor of single word reading across grades, suggesting that within-word sequential processing was not required for the successful recognition for this set of words. Factor mixture analysis revealed that our participants could be clustered into two classes, namely beginning and more advanced readers. Serial naming uniquely predicted single word reading only among the first class of readers, indicating that novice readers rely on a serial strategy to decode words. Yet, a considerable proportion of Grade 1 students were assigned to the second class, evidently being able to process short high-frequency words as unitized symbols. We consider these findings together with those from previous studies to challenge the hypothesis of a binary distinction between serial/sublexical and parallel/lexical processing in word reading. We argue instead that sequential processing in word reading operates on a continuum

  11. Reading Right: Korean Translation Manual. English for Special Purposes Series: Nursing Aide.

    Science.gov (United States)

    Park, Yong-Ok

    This Korean translation manual for nursing aides is designed to improve reading skills of U.S. immigrants. After short readings in Korean and English translations of vocabulary/phrases, comprehension, grammar, and language usage exercises are presented. Topical areas include: food, the hospital staff, body language, cleanliness in the hospital,…

  12. Musical experience, auditory perception and reading-related skills in children.

    Science.gov (United States)

    Banai, Karen; Ahissar, Merav

    2013-01-01

    The relationships between auditory processing and reading-related skills remain poorly understood despite intensive research. Here we focus on the potential role of musical experience as a confounding factor. Specifically we ask whether the pattern of correlations between auditory and reading related skills differ between children with different amounts of musical experience. Third grade children with various degrees of musical experience were tested on a battery of auditory processing and reading related tasks. Very poor auditory thresholds and poor memory skills were abundant only among children with no musical education. In this population, indices of auditory processing (frequency and interval discrimination thresholds) were significantly correlated with and accounted for up to 13% of the variance in reading related skills. Among children with more than one year of musical training, auditory processing indices were better, yet reading related skills were not correlated with them. A potential interpretation for the reduction in the correlations might be that auditory and reading-related skills improve at different rates as a function of musical training. Participants' previous musical training, which is typically ignored in studies assessing the relations between auditory and reading related skills, should be considered. Very poor auditory and memory skills are rare among children with even a short period of musical training, suggesting musical training could have an impact on both. The lack of correlation in the musically trained population suggests that a short period of musical training does not enhance reading related skills of individuals with within-normal auditory processing skills. Further studies are required to determine whether the associations between musical training, auditory processing and memory are indeed causal or whether children with poor auditory and memory skills are less likely to study music and if so, why this is the case.

  13. Musical experience, auditory perception and reading-related skills in children.

    Directory of Open Access Journals (Sweden)

    Karen Banai

    Full Text Available BACKGROUND: The relationships between auditory processing and reading-related skills remain poorly understood despite intensive research. Here we focus on the potential role of musical experience as a confounding factor. Specifically we ask whether the pattern of correlations between auditory and reading related skills differ between children with different amounts of musical experience. METHODOLOGY/PRINCIPAL FINDINGS: Third grade children with various degrees of musical experience were tested on a battery of auditory processing and reading related tasks. Very poor auditory thresholds and poor memory skills were abundant only among children with no musical education. In this population, indices of auditory processing (frequency and interval discrimination thresholds were significantly correlated with and accounted for up to 13% of the variance in reading related skills. Among children with more than one year of musical training, auditory processing indices were better, yet reading related skills were not correlated with them. A potential interpretation for the reduction in the correlations might be that auditory and reading-related skills improve at different rates as a function of musical training. CONCLUSIONS/SIGNIFICANCE: Participants' previous musical training, which is typically ignored in studies assessing the relations between auditory and reading related skills, should be considered. Very poor auditory and memory skills are rare among children with even a short period of musical training, suggesting musical training could have an impact on both. The lack of correlation in the musically trained population suggests that a short period of musical training does not enhance reading related skills of individuals with within-normal auditory processing skills. Further studies are required to determine whether the associations between musical training, auditory processing and memory are indeed causal or whether children with poor auditory and

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

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

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

  17. A Reading of Joseph Conrad's The Tale

    OpenAIRE

    Zadeh, Mohammad Reza Modarres

    2013-01-01

    The Tale is a short story by Joseph Conrad. Typical of a Conrad story it is set at sea. The sea is symbolic of the unconscious and this story may be read as a story of the unconscious. On the outside, it seems simple; a man tells a woman a tale of the commanding officer of a patrol ship who gives false directions to another ship and sends it to its doom. In between the lines of the seemingly simple plot, however, can be read another tale; one which speaks of a human sea deeper than the sea of...

  18. Read length and repeat resolution: Exploring prokaryote genomes using next-generation sequencing technologies

    KAUST Repository

    Cahill, Matt J.

    2010-07-12

    Background: There are a growing number of next-generation sequencing technologies. At present, the most cost-effective options also produce the shortest reads. However, even for prokaryotes, there is uncertainty concerning the utility of these technologies for the de novo assembly of complete genomes. This reflects an expectation that short reads will be unable to resolve small, but presumably abundant, repeats. Methodology/Principal Findings: Using a simple model of repeat assembly, we develop and test a technique that, for any read length, can estimate the occurrence of unresolvable repeats in a genome, and thus predict the number of gaps that would need to be closed to produce a complete sequence. We apply this technique to 818 prokaryote genome sequences. This provides a quantitative assessment of the relative performance of various lengths. Notably, unpaired reads of only 150nt can reconstruct approximately 50% of the analysed genomes with fewer than 96 repeat-induced gaps. Nonetheless, there is considerable variation amongst prokaryotes. Some genomes can be assembled to near contiguity using very short reads while others require much longer reads. Conclusions: Given the diversity of prokaryote genomes, a sequencing strategy should be tailored to the organism under study. Our results will provide researchers with a practical resource to guide the selection of the appropriate read length. 2010 Cahill et al.

  19. Read length and repeat resolution: exploring prokaryote genomes using next-generation sequencing technologies.

    Directory of Open Access Journals (Sweden)

    Matt J Cahill

    Full Text Available BACKGROUND: There are a growing number of next-generation sequencing technologies. At present, the most cost-effective options also produce the shortest reads. However, even for prokaryotes, there is uncertainty concerning the utility of these technologies for the de novo assembly of complete genomes. This reflects an expectation that short reads will be unable to resolve small, but presumably abundant, repeats. METHODOLOGY/PRINCIPAL FINDINGS: Using a simple model of repeat assembly, we develop and test a technique that, for any read length, can estimate the occurrence of unresolvable repeats in a genome, and thus predict the number of gaps that would need to be closed to produce a complete sequence. We apply this technique to 818 prokaryote genome sequences. This provides a quantitative assessment of the relative performance of various lengths. Notably, unpaired reads of only 150nt can reconstruct approximately 50% of the analysed genomes with fewer than 96 repeat-induced gaps. Nonetheless, there is considerable variation amongst prokaryotes. Some genomes can be assembled to near contiguity using very short reads while others require much longer reads. CONCLUSIONS: Given the diversity of prokaryote genomes, a sequencing strategy should be tailored to the organism under study. Our results will provide researchers with a practical resource to guide the selection of the appropriate read length.

  20. Read length and repeat resolution: Exploring prokaryote genomes using next-generation sequencing technologies

    KAUST Repository

    Cahill, Matt J.; Kö ser, Claudio U.; Ross, Nicholas E.; Archer, John A.C.

    2010-01-01

    Background: There are a growing number of next-generation sequencing technologies. At present, the most cost-effective options also produce the shortest reads. However, even for prokaryotes, there is uncertainty concerning the utility of these technologies for the de novo assembly of complete genomes. This reflects an expectation that short reads will be unable to resolve small, but presumably abundant, repeats. Methodology/Principal Findings: Using a simple model of repeat assembly, we develop and test a technique that, for any read length, can estimate the occurrence of unresolvable repeats in a genome, and thus predict the number of gaps that would need to be closed to produce a complete sequence. We apply this technique to 818 prokaryote genome sequences. This provides a quantitative assessment of the relative performance of various lengths. Notably, unpaired reads of only 150nt can reconstruct approximately 50% of the analysed genomes with fewer than 96 repeat-induced gaps. Nonetheless, there is considerable variation amongst prokaryotes. Some genomes can be assembled to near contiguity using very short reads while others require much longer reads. Conclusions: Given the diversity of prokaryote genomes, a sequencing strategy should be tailored to the organism under study. Our results will provide researchers with a practical resource to guide the selection of the appropriate read length. 2010 Cahill et al.

  1. GLOSSARY TO READINGS IN HINDI LITERATURE.

    Science.gov (United States)

    Wisconsin Univ., Madison. Indian Language and Area Center.

    INCLUDED IN THIS GLOSSARY ARE THE IMPORTANT VOCABULARY ITEMS WHICH APPEAR IN THE VOLUME OF READINGS. THESE ITEMS ARE ARRANGED BY SELECTION AND ARE IN SERIAL ORDER. THE LISTING INCLUDES THE DEVANAGARI FORM, AN ABBREVIATION OF THE FORM CLASS, AND A SHORT ENGLISH GLOSS. WHEN A NUMBER OF TRANSLATIONS ARE POSSIBLE, THE FIRST ONE GIVEN IS APPROPRIATE TO…

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

  3. The novel as short story

    Directory of Open Access Journals (Sweden)

    Kirk Schlueter

    2013-06-01

    Full Text Available In recent history, the novel has been thought of and defined primarily as a long prose narrative. However, this has not been the case historically, as the original meaning of "novel" was for "a piece of news" or "a short story or novella." Returning to this original definition, I propose a new way of viewing the work known contemporarily as the novel as a collection, or sequence, of united short stories rather than a single indivisible work, with the component short stories or novellas comprising the sequence renamed as "novels." A brief examination of several classic works traditionally considered novels serves to illustrate how this change in definition will affect reading.

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

  5. Characterizing preservice Teacherʼs responses to literacy: Read alouds a way to experience the joy for reading

    Directory of Open Access Journals (Sweden)

    Judith Castellanos

    2011-04-01

    Full Text Available This article reports on a small-scale project which central purpose was to incorporate read-alouds in a pre-intermediate English as a foreign language class of preservice teachers during three weeks. Students responded orally and in a written way on their journals to these readings showing understanding of the texts, relating their personal experiences and / or making connections to them. The project involved students of the undergraduate program in English teaching at Universidad Distrital Francisco José de Caldas, Bogotá. In all, 19 students were involved in the project. Data collection sources for this project include studentsʼ journals, after the fact notes on studentsʼ oral interactions and a group interview. Among the findings observed in this inquiry project include the intertextual connections (Short, 1993 students make across the texts read in class with their personal experiences. Most studentsʼ oral responses were characterized by code-switching; in general most students code switched depending on the difficulty of the answer. Students benefited from the reading-alouds in terms of opportunities to interact among themselves, practice their oral and written skills, and enjoy the pleasures of reading, thus building ground to a positive experience that may be emulated in their future teaching exercise. Finally, I discuss some implications of read-alouds with preservice teachers and teacher education programs in Colombia.

  6. Detection of target phonemes in spontaneous and read speech.

    Science.gov (United States)

    Mehta, G; Cutler, A

    1988-01-01

    Although spontaneous speech occurs more frequently in most listeners' experience than read speech, laboratory studies of human speech recognition typically use carefully controlled materials read from a script. The phonological and prosodic characteristics of spontaneous and read speech differ considerably, however, which suggests that laboratory results may not generalise to the recognition of spontaneous speech. In the present study listeners were presented with both spontaneous and read speech materials, and their response time to detect word-initial target phonemes was measured. Responses were, overall, equally fast in each speech mode. However, analysis of effects previously reported in phoneme detection studies revealed significant differences between speech modes. In read speech but not in spontaneous speech, later targets were detected more rapidly than targets preceded by short words. In contrast, in spontaneous speech but not in read speech, targets were detected more rapidly in accented than in unaccented words and in strong than in weak syllables. An explanation for this pattern is offered in terms of characteristic prosodic differences between spontaneous and read speech. The results support claims from previous work that listeners pay great attention to prosodic information in the process of recognising speech.

  7. 3 ns single-shot read-out in a quantum dot-based memory structure

    International Nuclear Information System (INIS)

    Nowozin, T.; Bimberg, D.; Beckel, A.; Lorke, A.; Geller, M.

    2014-01-01

    Fast read-out of two to six charges per dot from the ground and first excited state in a quantum dot (QD)-based memory is demonstrated using a two-dimensional electron gas. Single-shot measurements on modulation-doped field-effect transistor structures with embedded InAs/GaAs QDs show read-out times as short as 3 ns. At low temperature (T = 4.2 K) this read-out time is still limited by the parasitics of the setup and the device structure. Faster read-out times and a larger read-out signal are expected for an improved setup and device structure

  8. The relationship between working memory and L2 reading comprehension

    Directory of Open Access Journals (Sweden)

    Mohammadtaghi Shahnazari-Dorcheh

    2014-08-01

    Full Text Available Since an important role for working memory has been found in the first language acquisition (e.g., Daneman, 1991 Daneman & Green, 1986 Waters & Caplan, 1996, research on the role of working memory is emerging as an area of concern for second language acquisition (e.g., Atkins & Baddeley, 1998 Miyake & Freidman, 1998 Robinson, 1995, 2002, 2005. The present study focused on the role of working memory capacity in the development of second language reading ability. 55 L1 Persian EFL learners at three proficiency levels from a private language school participated in this study. They completed a battery of reading and working memory measures. Memory measures included phonological short-term memory, and reading span test (RST. Reading measures included two expository reading comprehension tests. Multiple regression analysis was applied to determine whether there are any significant relationships between working memory capacity and reading measures. Results of this study indicated a significant relationship between working memory capacity (as measured by RST and reading ability at lower levels of proficiency.

  9. Maximizing Reading Narrative Text Ability by Probing Prompting Learning Technique

    Directory of Open Access Journals (Sweden)

    Wiwied Pratiwi

    2017-12-01

    Full Text Available The objective of this research was to know whether Probing Prompting Learning Technique can be used to get the maximum effect of students’ reading narrative ability in teaching and learning process. This research was applied collaborative action reEsearch, this research was done in two cycle. The subject of this research was 23 students at tenth grade of SMA Kartikatama Metro. The result of the research showed that the Probing Prompting Learning Technique is useful and effective to help students get maximum effect of their reading. Based on the results of the questionnaire obtained an average percentage of 95%, it indicated that application of Probing Prompting Learning Technique in teaching l reading was appropriately applied. In short that students’ responses toward Probing Prompting Learning Technique in teaching reading was positive. In conclusion, Probing Prompting Learning Technique can get maximum effect of students’ reading ability. In relation to the result of the reserach, some suggestion are offered to english teacher, that  the use of Probing Prompting learning Technique in teaching reading will get the maximum effect of students’ reading abilty.

  10. Kindergarteners' performance in a sound-symbol paradigm predicts early reading.

    Science.gov (United States)

    Horbach, Josefine; Scharke, Wolfgang; Cröll, Jennifer; Heim, Stefan; Günther, Thomas

    2015-11-01

    The current study examined the role of serial processing of newly learned sound-symbol associations in early reading acquisition. A computer-based sound-symbol paradigm (SSP) was administered to 243 children during their last year of kindergarten (T1), and their reading performance was assessed 1 year later in first grade (T2). Results showed that performance on the SSP measured before formal reading instruction was associated with later reading development. At T1, early readers performed significantly better than nonreaders in learning correspondences between sounds and symbols as well as in applying those correspondences in a serial manner. At T2, SSP performance measured at T1 was positively associated with reading performance. Importantly, serial application of newly learned correspondences at T1 explained unique variance in first-grade reading performance in nonreaders over and above other verbal predictors, including phonological awareness, verbal short-term memory, and rapid automatized naming. Consequently, the SSP provides a promising way to study aspects of reading in preliterate children. Copyright © 2015 Elsevier Inc. All rights reserved.

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

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

  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. De Novo Assembly of Complete Chloroplast Genomes from Non-model Species Based on a K-mer Frequency-Based Selection of Chloroplast Reads from Total DNA Sequences

    Directory of Open Access Journals (Sweden)

    Shairul Izan

    2017-08-01

    Full Text Available Whole Genome Shotgun (WGS sequences of plant species often contain an abundance of reads that are derived from the chloroplast genome. Up to now these reads have generally been identified and assembled into chloroplast genomes based on homology to chloroplasts from related species. This re-sequencing approach may select against structural differences between the genomes especially in non-model species for which no close relatives have been sequenced before. The alternative approach is to de novo assemble the chloroplast genome from total genomic DNA sequences. In this study, we used k-mer frequency tables to identify and extract the chloroplast reads from the WGS reads and assemble these using a highly integrated and automated custom pipeline. Our strategy includes steps aimed at optimizing assemblies and filling gaps which are left due to coverage variation in the WGS dataset. We have successfully de novo assembled three complete chloroplast genomes from plant species with a range of nuclear genome sizes to demonstrate the universality of our approach: Solanum lycopersicum (0.9 Gb, Aegilops tauschii (4 Gb and Paphiopedilum henryanum (25 Gb. We also highlight the need to optimize the choice of k and the amount of data used. This new and cost-effective method for de novo short read assembly will facilitate the study of complete chloroplast genomes with more accurate analyses and inferences, especially in non-model plant genomes.

  15. Reading in developmental prosopagnosia: Evidence for a dissociation between word and face recognition.

    Science.gov (United States)

    Starrfelt, Randi; Klargaard, Solja K; Petersen, Anders; Gerlach, Christian

    2018-02-01

    Recent models suggest that face and word recognition may rely on overlapping cognitive processes and neural regions. In support of this notion, face recognition deficits have been demonstrated in developmental dyslexia. Here we test whether the opposite association can also be found, that is, impaired reading in developmental prosopagnosia. We tested 10 adults with developmental prosopagnosia and 20 matched controls. All participants completed the Cambridge Face Memory Test, the Cambridge Face Perception test and a Face recognition questionnaire used to quantify everyday face recognition experience. Reading was measured in four experimental tasks, testing different levels of letter, word, and text reading: (a) single word reading with words of varying length,(b) vocal response times in single letter and short word naming, (c) recognition of single letters and short words at brief exposure durations (targeting the word superiority effect), and d) text reading. Participants with developmental prosopagnosia performed strikingly similar to controls across the four reading tasks. Formal analysis revealed a significant dissociation between word and face recognition, as the difference in performance with faces and words was significantly greater for participants with developmental prosopagnosia than for controls. Adult developmental prosopagnosics read as quickly and fluently as controls, while they are seemingly unable to learn efficient strategies for recognizing faces. We suggest that this is due to the differing demands that face and word recognition put on the perceptual system. (PsycINFO Database Record (c) 2018 APA, all rights reserved).

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

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

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

  19. Development of high-throughput SNP-based genotyping in Acacia auriculiformis x A. mangium hybrids using short-read transcriptome data

    Directory of Open Access Journals (Sweden)

    Wong Melissa ML

    2012-12-01

    Full Text Available Abstract Background Next Generation Sequencing has provided comprehensive, affordable and high-throughput DNA sequences for Single Nucleotide Polymorphism (SNP discovery in Acacia auriculiformis and Acacia mangium. Like other non-model species, SNP detection and genotyping in Acacia are challenging due to lack of genome sequences. The main objective of this study is to develop the first high-throughput SNP genotyping assay for linkage map construction of A. auriculiformis x A. mangium hybrids. Results We identified a total of 37,786 putative SNPs by aligning short read transcriptome data from four parents of two Acacia hybrid mapping populations using Bowtie against 7,839 de novo transcriptome contigs. Given a set of 10 validated SNPs from two lignin genes, our in silico SNP detection approach is highly accurate (100% compared to the traditional in vitro approach (44%. Further validation of 96 SNPs using Illumina GoldenGate Assay gave an overall assay success rate of 89.6% and conversion rate of 37.5%. We explored possible factors lowering assay success rate by predicting exon-intron boundaries and paralogous genes of Acacia contigs using Medicago truncatula genome as reference. This assessment revealed that presence of exon-intron boundary is the main cause (50% of assay failure. Subsequent SNPs filtering and improved assay design resulted in assay success and conversion rate of 92.4% and 57.4%, respectively based on 768 SNPs genotyping. Analysis of clustering patterns revealed that 27.6% of the assays were not reproducible and flanking sequence might play a role in determining cluster compression. In addition, we identified a total of 258 and 319 polymorphic SNPs in A. auriculiformis and A. mangium natural germplasms, respectively. Conclusion We have successfully discovered a large number of SNP markers in A. auriculiformis x A. mangium hybrids using next generation transcriptome sequencing. By using a reference genome from the most closely

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

  1. Literacy of 8th and 9th grade pupils with reading and writing disabilities in comparison with pupils without reading and writing disabilities

    OpenAIRE

    Fijavž, Katarina

    2017-01-01

    For the last decade literacy and illiteracy of the young at the end of their education has been very often the subject under discussion. Already in 1951 UNESCO provided the definition of literacy, which says that literacy is the ability of a person who can with understanding both read and write a short, simple statement of his everyday life. The definition was later on expanded to the possession by an individual of the knowledge and skills of reading and writing, which enable him to effective...

  2. Playing hide and seek with repeats in local and global de novo transcriptome assembly of short RNA-seq reads.

    Science.gov (United States)

    Lima, Leandro; Sinaimeri, Blerina; Sacomoto, Gustavo; Lopez-Maestre, Helene; Marchet, Camille; Miele, Vincent; Sagot, Marie-France; Lacroix, Vincent

    2017-01-01

    The main challenge in de novo genome assembly of DNA-seq data is certainly to deal with repeats that are longer than the reads. In de novo transcriptome assembly of RNA-seq reads, on the other hand, this problem has been underestimated so far. Even though we have fewer and shorter repeated sequences in transcriptomics, they do create ambiguities and confuse assemblers if not addressed properly. Most transcriptome assemblers of short reads are based on de Bruijn graphs (DBG) and have no clear and explicit model for repeats in RNA-seq data, relying instead on heuristics to deal with them. The results of this work are threefold. First, we introduce a formal model for representing high copy-number and low-divergence repeats in RNA-seq data and exploit its properties to infer a combinatorial characteristic of repeat-associated subgraphs. We show that the problem of identifying such subgraphs in a DBG is NP-complete. Second, we show that in the specific case of local assembly of alternative splicing (AS) events, we can implicitly avoid such subgraphs, and we present an efficient algorithm to enumerate AS events that are not included in repeats. Using simulated data, we show that this strategy is significantly more sensitive and precise than the previous version of KisSplice (Sacomoto et al. in WABI, pp 99-111, 1), Trinity (Grabherr et al. in Nat Biotechnol 29(7):644-652, 2), and Oases (Schulz et al. in Bioinformatics 28(8):1086-1092, 3), for the specific task of calling AS events. Third, we turn our focus to full-length transcriptome assembly, and we show that exploring the topology of DBGs can improve de novo transcriptome evaluation methods. Based on the observation that repeats create complicated regions in a DBG, and when assemblers try to traverse these regions, they can infer erroneous transcripts, we propose a measure to flag transcripts traversing such troublesome regions, thereby giving a confidence level for each transcript. The originality of our work when

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

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

  5. Subjective Impressions Do Not Mirror Online Reading Effort: Concurrent EEG-Eyetracking Evidence from the Reading of Books and Digital Media

    Science.gov (United States)

    Kretzschmar, Franziska; Pleimling, Dominique; Hosemann, Jana; Füssel, Stephan; Bornkessel-Schlesewsky, Ina; Schlesewsky, Matthias

    2013-01-01

    In the rapidly changing circumstances of our increasingly digital world, reading is also becoming an increasingly digital experience: electronic books (e-books) are now outselling print books in the United States and the United Kingdom. Nevertheless, many readers still view e-books as less readable than print books. The present study thus used combined EEG and eyetracking measures in order to test whether reading from digital media requires higher cognitive effort than reading conventional books. Young and elderly adults read short texts on three different reading devices: a paper page, an e-reader and a tablet computer and answered comprehension questions about them while their eye movements and EEG were recorded. The results of a debriefing questionnaire replicated previous findings in that participants overwhelmingly chose the paper page over the two electronic devices as their preferred reading medium. Online measures, by contrast, showed shorter mean fixation durations and lower EEG theta band voltage density – known to covary with memory encoding and retrieval – for the older adults when reading from a tablet computer in comparison to the other two devices. Young adults showed comparable fixation durations and theta activity for all three devices. Comprehension accuracy did not differ across the three media for either group. We argue that these results can be explained in terms of the better text discriminability (higher contrast) produced by the backlit display of the tablet computer. Contrast sensitivity decreases with age and degraded contrast conditions lead to longer reading times, thus supporting the conclusion that older readers may benefit particularly from the enhanced contrast of the tablet. Our findings thus indicate that people's subjective evaluation of digital reading media must be dissociated from the cognitive and neural effort expended in online information processing while reading from such devices. PMID:23405265

  6. Subjective impressions do not mirror online reading effort: concurrent EEG-eyetracking evidence from the reading of books and digital media.

    Science.gov (United States)

    Kretzschmar, Franziska; Pleimling, Dominique; Hosemann, Jana; Füssel, Stephan; Bornkessel-Schlesewsky, Ina; Schlesewsky, Matthias

    2013-01-01

    In the rapidly changing circumstances of our increasingly digital world, reading is also becoming an increasingly digital experience: electronic books (e-books) are now outselling print books in the United States and the United Kingdom. Nevertheless, many readers still view e-books as less readable than print books. The present study thus used combined EEG and eyetracking measures in order to test whether reading from digital media requires higher cognitive effort than reading conventional books. Young and elderly adults read short texts on three different reading devices: a paper page, an e-reader and a tablet computer and answered comprehension questions about them while their eye movements and EEG were recorded. The results of a debriefing questionnaire replicated previous findings in that participants overwhelmingly chose the paper page over the two electronic devices as their preferred reading medium. Online measures, by contrast, showed shorter mean fixation durations and lower EEG theta band voltage density--known to covary with memory encoding and retrieval--for the older adults when reading from a tablet computer in comparison to the other two devices. Young adults showed comparable fixation durations and theta activity for all three devices. Comprehension accuracy did not differ across the three media for either group. We argue that these results can be explained in terms of the better text discriminability (higher contrast) produced by the backlit display of the tablet computer. Contrast sensitivity decreases with age and degraded contrast conditions lead to longer reading times, thus supporting the conclusion that older readers may benefit particularly from the enhanced contrast of the tablet. Our findings thus indicate that people's subjective evaluation of digital reading media must be dissociated from the cognitive and neural effort expended in online information processing while reading from such devices.

  7. Subjective impressions do not mirror online reading effort: concurrent EEG-eyetracking evidence from the reading of books and digital media.

    Directory of Open Access Journals (Sweden)

    Franziska Kretzschmar

    Full Text Available In the rapidly changing circumstances of our increasingly digital world, reading is also becoming an increasingly digital experience: electronic books (e-books are now outselling print books in the United States and the United Kingdom. Nevertheless, many readers still view e-books as less readable than print books. The present study thus used combined EEG and eyetracking measures in order to test whether reading from digital media requires higher cognitive effort than reading conventional books. Young and elderly adults read short texts on three different reading devices: a paper page, an e-reader and a tablet computer and answered comprehension questions about them while their eye movements and EEG were recorded. The results of a debriefing questionnaire replicated previous findings in that participants overwhelmingly chose the paper page over the two electronic devices as their preferred reading medium. Online measures, by contrast, showed shorter mean fixation durations and lower EEG theta band voltage density--known to covary with memory encoding and retrieval--for the older adults when reading from a tablet computer in comparison to the other two devices. Young adults showed comparable fixation durations and theta activity for all three devices. Comprehension accuracy did not differ across the three media for either group. We argue that these results can be explained in terms of the better text discriminability (higher contrast produced by the backlit display of the tablet computer. Contrast sensitivity decreases with age and degraded contrast conditions lead to longer reading times, thus supporting the conclusion that older readers may benefit particularly from the enhanced contrast of the tablet. Our findings thus indicate that people's subjective evaluation of digital reading media must be dissociated from the cognitive and neural effort expended in online information processing while reading from such devices.

  8. Using the Dictionary for Improving Adolescents' Reading Comprehension of Short Scientific Texts (Uso del diccionario para mejorar la comprensión lectora de textos científicos cortos en inglés con adolescentes)

    Science.gov (United States)

    Becerra Cortés, Ximena

    2013-01-01

    This paper reports on an innovative and action research project which focused on the use of the dictionary and the prior knowledge of Colombian high school students to improve their reading comprehension of short scientific texts. Data collection instruments included students' work gathered during two workshops, field notes, and a questionnaire.…

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

  10. Mathematical analysis and algorithms for efficiently and accurately implementing stochastic simulations of short-term synaptic depression and facilitation

    Directory of Open Access Journals (Sweden)

    Mark D McDonnell

    2013-05-01

    Full Text Available The release of neurotransmitter vesicles after arrival of a pre-synaptic action potential at cortical synapses is known to be a stochastic process, as is the availability of vesicles for release. These processes are known to also depend on the recent history of action-potential arrivals, and this can be described in terms of time-varying probabilities of vesicle release. Mathematical models of such synaptic dynamics frequently are based only on the mean number of vesicles released by each pre-synaptic action potential, since if it is assumed there are sufficiently many vesicle sites, then variance is small. However, it has been shown recently that variance across sites can be significant for neuron and network dynamics, and this suggests the potential importance of studying short-term plasticity using simulations that do generate trial-to-trial variability. Therefore, in this paper we study several well-known conceptual models for stochastic availability and release. We state explicitly the random variables that these models describe and propose efficient algorithms for accurately implementing stochastic simulations of these random variables in software or hardware. Our results are complemented by mathematical analysis and statement of pseudo-code algorithms.

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

  12. Lateralization of posterior alpha EEG reflects the distribution of spatial attention during saccadic reading.

    Science.gov (United States)

    Kornrumpf, Benthe; Dimigen, Olaf; Sommer, Werner

    2017-06-01

    Visuospatial attention is an important mechanism in reading that governs the uptake of information from foveal and parafoveal regions of the visual field. However, the spatiotemporal dynamics of how attention is allocated during eye fixations are not completely understood. The current study explored the use of EEG alpha-band oscillations to investigate the spatial distribution of attention during reading. We reanalyzed two data sets, focusing on the lateralization of alpha activity at posterior scalp sites. In each experiment, participants read short lists of German nouns in two paradigms: either by freely moving their eyes (saccadic reading) or by fixating the screen center while the text moved passively from right to left at the same average speed (RSVP paradigm). In both paradigms, upcoming words were either visible or masked, and foveal processing load was manipulated by varying the words' lexical frequencies. Posterior alpha lateralization revealed a sustained rightward bias of attention during saccadic reading, but not in the RSVP paradigm. Interestingly, alpha lateralization was not influenced by word frequency (foveal load) or preview during the preceding fixation. Hence, alpha did not reflect transient attention shifts within a given fixation. However, in both experiments, we found that in the saccadic reading condition a stronger alpha lateralization shortly before a saccade predicted shorter fixations on the subsequently fixated word. These results indicate that alpha lateralization can serve as a measure of attention deployment and its link to oculomotor behavior in reading. © 2017 Society for Psychophysiological Research.

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

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

  15. Visual processing in reading disorders and attention-deficit/hyperactivity disorder and its contribution to basic reading ability.

    Science.gov (United States)

    Kibby, Michelle Y; Dyer, Sarah M; Vadnais, Sarah A; Jagger, Audreyana C; Casher, Gabriel A; Stacy, Maria

    2015-01-01

    Whether visual processing deficits are common in reading disorders (RD), and related to reading ability in general, has been debated for decades. The type of visual processing affected also is debated, although visual discrimination and short-term memory (STM) may be more commonly related to reading ability. Reading disorders are frequently comorbid with ADHD, and children with ADHD often have subclinical reading problems. Hence, children with ADHD were used as a comparison group in this study. ADHD and RD may be dissociated in terms of visual processing. Whereas RD may be associated with deficits in visual discrimination and STM for order, ADHD is associated with deficits in visual-spatial processing. Thus, we hypothesized that children with RD would perform worse than controls and children with ADHD only on a measure of visual discrimination and a measure of visual STM that requires memory for order. We expected all groups would perform comparably on the measure of visual STM that does not require sequential processing. We found children with RD or ADHD were commensurate to controls on measures of visual discrimination and visual STM that do not require sequential processing. In contrast, both RD groups (RD, RD/ADHD) performed worse than controls on the measure of visual STM that requires memory for order, and children with comorbid RD/ADHD performed worse than those with ADHD. In addition, of the three visual measures, only sequential visual STM predicted reading ability. Hence, our findings suggest there is a deficit in visual sequential STM that is specific to RD and is related to basic reading ability. The source of this deficit is worthy of further research, but it may include both reduced memory for order and poorer verbal mediation.

  16. mpscan: Fast Localisation of Multiple Reads in Genomes

    Science.gov (United States)

    Rivals, Eric; Salmela, Leena; Kiiskinen, Petteri; Kalsi, Petri; Tarhio, Jorma

    With Next Generation Sequencers, sequence based transcriptomic or epigenomic assays yield millions of short sequence reads that need to be mapped back on a reference genome. The upcoming versions of these sequencers promise even higher sequencing capacities; this may turn the read mapping task into a bottleneck for which alternative pattern matching approaches must be experimented. We present an algorithm and its implementation, called mpscan, which uses a sophisticated filtration scheme to match a set of patterns/reads exactly on a sequence. mpscan can search for millions of reads in a single pass through the genome without indexing its sequence. Moreover, we show that mpscan offers an optimal average time complexity, which is sublinear in the text length, meaning that it does not need to examine all sequence positions. Comparisons with BLAT-like tools and with six specialised read mapping programs (like bowtie or zoom) demonstrate that mpscan also is the fastest algorithm in practice for exact matching. Our accuracy and scalability comparisons reveal that some tools are inappropriate for read mapping. Moreover, we provide evidence suggesting that exact matching may be a valuable solution in some read mapping applications. As most read mapping programs somehow rely on exact matching procedures to perform approximate pattern mapping, the filtration scheme we experimented may reveal useful in the design of future algorithms. The absence of genome index gives mpscan its low memory requirement and flexibility that let it run on a desktop computer and avoids a time-consuming genome preprocessing.

  17. The Effect of the Reader's Background on Reading Comprehension Performance

    Directory of Open Access Journals (Sweden)

    Bushra Saadoon Mohammed Al-Noori

    2014-12-01

    Full Text Available This study aims at measuring the amount of the effect of the reader's background knowledge on performance in reading comprehension tests through the assessment of information gained in reading comprehension (RC tests across-four testing techniques, short answer questions ,true-false items , multiple - choice items , and cloze test and re-test. This technique involves the examinees in two types of tasks, i.e. pre-reading and post -reading task. Two hypotheses have been proposed to achieve the aims of this study. They are  1-There are no significant differences between the pre-reading and post-reading performances of examinees on reading comprehension(RC. 2-There are no significant differences in information gain scores across the different techniques of testing reading comprehension (RC in EFL. To verify the validity of these two hypotheses, a number of statistical procedures have been used such as arithmetical mean, t-test for correlated and independent samples to analyze the performance of third and fourth year College students studying at the Department of English at University of Baghdad /Ibn Rushd College of Education for Humanities on two reading passages taken from TOEFL practice tests (2011. The analysis of the data has shown the following results: 1-The background knowledge has an effect on the performance on reading comprehension (RC. 2-There is a significant difference in students' performance on reading comprehension (RC. 3-The effect of background knowledge is investable on reading comprehension (RC tests, but it can be identified or neutralized. Based on these conclusions, the researcher presented a number of recommendations.

  18. Simple Assessment of Nitrogen Nutrition Index in Summer Maize by Using Chlorophyll Meter Readings.

    Science.gov (United States)

    Zhao, Ben; Ata-Ul-Karim, Syed Tahir; Liu, Zhandong; Zhang, Jiyang; Xiao, Junfu; Liu, Zugui; Qin, Anzhen; Ning, Dongfeng; Yang, Qiuxia; Zhang, Yonghui; Duan, Aiwang

    2018-01-01

    Rapid and non-destructive diagnostic tools to accurately assess crop nitrogen nutrition index (NNI) are imperative for improving crop nitrogen (N) diagnosis and sustaining crop production. This study was aimed to develop the relationships among NNI, leaf N gradient, chlorophyll meter (CM) readings gradient, and positional differences chlorophyll meter index [PDCMI, the ratio of CM readings between different leaf layers (LLs) of crop canopy] and to validate the accuracy and stability of these relationships across the different LLs, years, sites, and cultivars. Six multi-N rates (0-320 kg ha -1 ) field experiments were conducted with four summer maize cultivars (Zhengdan958, Denghai605, Xundan20, and Denghai661) at two different sites located in China. Six summer maize plants per plot were harvested at each sampling stage to assess NNI, leaf N concentration and CM readings of different LLs during the vegetative growth period. The results showed that the leaf N gradient, CM readings gradient and PDCMI of different LLs decreased, while the NNI values increased with increasing N supply. The leaf N gradient and CM readings gradient increased gradually from top to bottom of the canopy and CM readings of the bottom LL were more sensitive to changes in plant N concentration. The significantly positive relationship between NNI and CM readings of different LLs ( LL 1 to LL 3) was observed, yet these relationships varied across the years. In contrast, the relationships between NNI and PDCMI of different LLs ( LL 1 to LL 3) were significantly negative. The strongest relationship between PDCMI and NNI which was stable across the cultivars and years was observed for PDCMI1-3 (NNI = -5.74 × PDCMI1-3+1.5, R 2 = 0.76 ** ). Additionally, the models developed in this study were validated with the data acquired from two independent experiments to assess their accuracy of prediction. The root mean square error value of 0.1 indicated that the most accurate and robust relationship was

  19. Developmental relations between reading comprehension and reading strategies

    OpenAIRE

    Muijselaar, M.M.L.; Swart, N.M.; Steenbeek-Planting, E.G.; Droop, W.; Verhoeven, L.T.W.; Jong, P.F. de

    2017-01-01

    We examined the developmental relations between knowledge of reading strategies and reading comprehension in a longitudinal study of 312 Dutch children from the beginning of fourth grade to the end of fifth grade. Measures for reading comprehension, reading strategies, reading fluency, vocabulary, and working memory were administered. A structural equation model was constructed to estimate the unique relations between reading strategies and reading comprehension, while controlling for reading...

  20. Of a Village Bomoh and the Lottery: Content Schemata Influence on Second Language Reading

    Science.gov (United States)

    Radzi, Amizura Hanadi Mohd.; Aziz, Noor Hashima Abd.

    2013-01-01

    This paper discusses a study on the aspects of content schemata in second language reading, focusing on two contemporary short stories, i.e. "A Quid of Sirih, A Bowl of Water" and "The Lottery." The study explores the cognitive processes of one UiTM Perlis degree level student, reflecting on his L2 reading processes. The…

  1. Discovering the Unknown: Improving Detection of Novel Species and Genera from Short Reads

    Directory of Open Access Journals (Sweden)

    Gail L. Rosen

    2011-01-01

    “unknown” class and show that the modified version of PhymmBL has similar or better overall classification performance than the other modified algorithms, especially for the species-level and ultrashort reads. Finally, we evaluate theperformance of several algorithms on a real acid mine drainage dataset.

  2. Environmental sensors based on micromachined cantilevers with integrated read-out

    DEFF Research Database (Denmark)

    Boisen, Anja; Thaysen, Jacob; Jensenius, Henriette

    2000-01-01

    -out facilitates measurements in liquid. The probe has been successfully implemented in gaseous as well as in liquid experiments. For example, the probe has been used as an accurate and minute thermal sensor and as a humidity sensor. In liquid, the probe has been used to detect the presence of alcohol in water. (C......An AFM probe with integrated piezoresistive read-out has been developed and applied as a cantilever-based environmental sensor. The probe has a built-in reference cantilever, which makes it possible to subtract background drift directly in the measurement. Moreover, the integrated read...

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

  4. Numerical challenges of short range wake field calculations

    Energy Technology Data Exchange (ETDEWEB)

    Lau, Thomas; Gjonaj, Erion; Weiland, Thomas [Technische Universitaet Darmstadt (Germany). Institut fuer Theorie Elektromagnetischer Felder (TEMF)

    2011-07-01

    For present and future accelerator projects with ultra short bunches the accurate and reliable calculation of short range wake fields is an important issue. However, the numerical calculation of short range wake fields is a numerical challenging task. The presentation gives an overview over the numerical challenges and techniques for short range wake field calculations. Finally, some simulation results obtained by the program PBCI developed at the TU Darmstadt are presented.

  5. Teaching Reading

    Science.gov (United States)

    Day, Richard R.

    2013-01-01

    "Teaching Reading" uncovers the interactive processes that happen when people learn to read and translates them into a comprehensive easy-to-follow guide on how to teach reading. Richard Day's revelations on the nature of reading, reading strategies, reading fluency, reading comprehension, and reading objectives make fascinating…

  6. Slow Reading: Reading along "Lectio" Lines

    Science.gov (United States)

    Badley, K. Jo-Ann; Badley, Ken

    2011-01-01

    The medieval monastic movement preserved and developed reading practices--lectio--from ancient Greek pedagogy as a slow, mindful approach to reading for formation. This ancient way of reading, now better known as lectio divina, challenges the fast, pragmatic reading so characteristic of our time. We propose that the present moment may be ripe for…

  7. Revisiting the Relations between the WJ-IV Measures of Cattell-Horn-Carroll (CHC) Cognitive Abilities and Reading Achievement during the School-Age Years

    Science.gov (United States)

    Cormier, Damien C.; McGrew, Kevin S.; Bulut, Okan; Funamoto, Allyson

    2017-01-01

    This study examined associations between broad cognitive abilities (Fluid Reasoning [Gf], Short-Term Working Memory [Gwm], Long-Term Storage and Retrieval [Glr], Processing Speed [Gs], Comprehension-Knowledge [Gc], Visual Processing [Gv], and Auditory Processing [Ga]) and reading achievement (Basic Reading Skills, Reading Rate, Reading Fluency,…

  8. Improving reading in the primary grades.

    Science.gov (United States)

    Duke, Nell K; Block, Meghan K

    2012-01-01

    Almost fifteen years have passed since the publication of the National Research Council's seminal report Preventing Reading Difficulties in Young Children, which provided research-based recommendations on what could be done to better position students in prekindergarten through third grade for success in grade four and above. This article by Nell Duke and Meghan Block first examines whether specific key recommendations from the report have been implemented in U.S. classrooms. They find that recommendations regarding increased access to kindergarten and greater attention to and improvement of students' word-reading skills have been widely adopted. Others have not. Vocabulary and comprehension, long neglected in the primary grades, still appear to be neglected. Contrary to the report's recommendations, attention to building conceptual and content knowledge in science and social studies has actually decreased in the past fifteen years. In other words, the easier-to-master skills are being attended to, but the broader domains of accomplishment that constitute preparation for comprehension and learning in the later grades--vocabulary knowledge, comprehension strategy use, and conceptual and content knowledge--are being neglected. Near stagnation in fourth-grade students' comprehension achievement is thus unsurprising. The authors then turn to research and reviews of research on improving primary-grade reading published since 1998, when Preventing Reading Difficulties was issued. They discuss several instructional approaches identified as effective in improving word-reading skill, vocabulary and conceptual knowledge, comprehension strategies, and reading outside of school; they discuss advances in interventions for struggling readers, and in whole-school literacy reform. Duke and Block then identify three key obstacles that have prevented widespread adoption of these best practices in teaching reading. The first obstacle is a short-term orientation toward instruction and

  9. Fact vs fiction--how paratextual information shapes our reading processes.

    Science.gov (United States)

    Altmann, Ulrike; Bohrn, Isabel C; Lubrich, Oliver; Menninghaus, Winfried; Jacobs, Arthur M

    2014-01-01

    Our life is full of stories: some of them depict real-life events and were reported, e.g. in the daily news or in autobiographies, whereas other stories, as often presented to us in movies and novels, are fictional. However, we have only little insights in the neurocognitive processes underlying the reading of factual as compared to fictional contents. We investigated the neurocognitive effects of reading short narratives, labeled to be either factual or fictional. Reading in a factual mode engaged an activation pattern suggesting an action-based reconstruction of the events depicted in a story. This process seems to be past-oriented and leads to shorter reaction times at the behavioral level. In contrast, the brain activation patterns corresponding to reading fiction seem to reflect a constructive simulation of what might have happened. This is in line with studies on imagination of possible past or future events.

  10. Fact vs fiction—how paratextual information shapes our reading processes

    Science.gov (United States)

    Altmann, Ulrike; Bohrn, Isabel C.; Lubrich, Oliver; Menninghaus, Winfried; Jacobs, Arthur M.

    2014-01-01

    Our life is full of stories: some of them depict real-life events and were reported, e.g. in the daily news or in autobiographies, whereas other stories, as often presented to us in movies and novels, are fictional. However, we have only little insights in the neurocognitive processes underlying the reading of factual as compared to fictional contents. We investigated the neurocognitive effects of reading short narratives, labeled to be either factual or fictional. Reading in a factual mode engaged an activation pattern suggesting an action-based reconstruction of the events depicted in a story. This process seems to be past-oriented and leads to shorter reaction times at the behavioral level. In contrast, the brain activation patterns corresponding to reading fiction seem to reflect a constructive simulation of what might have happened. This is in line with studies on imagination of possible past or future events. PMID:22956671

  11. An Analysis on Reading Texts in Teaching Turkish to Foreigners

    Directory of Open Access Journals (Sweden)

    Adem İŞCAN

    2017-09-01

    Full Text Available Being one of the four basic language skills, reading has a great importance in teaching Turkish to foreigners. It is required to develop reading skills to develop vocabulary. There have been some problems in teaching Turkish as second language. These problems are generally related to difference in alphabet, inadequacy of the sources used in teaching Turkish, methods and techniques used and the texts used. The basic sources used in teaching Turkish to foreigners are texts. This study aims at determination of the opinions of students in Gaziosmanpaşa University and Ondokuz Mayıs University Turkish Education and Application Center (TOMER concerning Turkish reading texts. General browsing method was used in the study. The questionnaire comprising of 24 items was applied to 25 students in beginner level and 7 students in advanced level. With this study, it is foreseen to arrange the texts being the key stone according to the wishes of and in compliance with the levels of students; giving importance to pre-reading, reading and post-reading activities and including questions with short-answer about the text as well as questions to develop high level skills.

  12. Improving transcriptome assembly through error correction of high-throughput sequence reads

    Directory of Open Access Journals (Sweden)

    Matthew D. MacManes

    2013-07-01

    Full Text Available The study of functional genomics, particularly in non-model organisms, has been dramatically improved over the last few years by the use of transcriptomes and RNAseq. While these studies are potentially extremely powerful, a computationally intensive procedure, the de novo construction of a reference transcriptome must be completed as a prerequisite to further analyses. The accurate reference is critically important as all downstream steps, including estimating transcript abundance are critically dependent on the construction of an accurate reference. Though a substantial amount of research has been done on assembly, only recently have the pre-assembly procedures been studied in detail. Specifically, several stand-alone error correction modules have been reported on and, while they have shown to be effective in reducing errors at the level of sequencing reads, how error correction impacts assembly accuracy is largely unknown. Here, we show via use of a simulated and empiric dataset, that applying error correction to sequencing reads has significant positive effects on assembly accuracy, and should be applied to all datasets. A complete collection of commands which will allow for the production of Reptile corrected reads is available at https://github.com/macmanes/error_correction/tree/master/scripts and as File S1.

  13. Effects of Wh-Question Graphic Organizers on Reading Comprehension Skills of Students with Autism Spectrum Disorders

    Science.gov (United States)

    Bethune, Keri S.; Wood,Charles L.

    2013-01-01

    Students with autism spectrum disorders often have difficulty with reading comprehension. This study used a delayed multiple baseline across participants design to evaluate the effects of graphic organizers on the accuracy of wh-questions answered following short passage reading. Participants were three elementary-age students with autism spectrum…

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

  15. Materiality of a simulation: Scratch reading machine, 1931

    Directory of Open Access Journals (Sweden)

    Craig Saper

    2009-12-01

    Full Text Available Using Bob Brown's reading machine and the prepared texts for his machine, called readies, both designed in 1930, as an example of scratch turntablist techniques, suggests an alternative to narrow definitions of literacy and new ways to appreciate the history of scratch techniques. Brown's machine resembles the turntablist’s ability to rapidly shift reading (its direction, speed, and repetition rather than slowly flipping the pages of a book. Punctuation marks, in the readies, become visual analogies. For movement we see em-dashes (— that also, by definition, indicate that the sentence was interrupted or cut short. The old uses of punctuation, such as employment of periods to mark the end of a sentence, disappear. The result looks like a script for a turntablist’s performance, and dj Herc starts to sound like a reading teacher. An online simulation of Brown's machine, http://www.readies.org, reproduce, or approximate, the motion, scratch, jerking, flickering, and visual effects produced or illuminated with the machine. Those supplemental aspects of reading are always already part of reading. The supplement (movement, visuality, mechanicity to traditional notions of literacy usually remain part of an implicate process. The reading machine and scratch techniques are not simply a new conduit for the same supposedly natural process. The scratch reading highlights what Jacques Derrida calls the "virtual multimedia" (of reading print on paper. The increasing prevalence, even omnipresent and [to some critics] epidemic, use of text(ing machines, something outside or beside traditional literacy, the scratch-meaning becomes foregrounded. Brown's machine puts the natural process of reading under erasure or scratch (simply by adjusting the speed, direction, and layout. dj Herc did the same for music.

  16. Eye Movement Control in Scene Viewing and Reading: Evidence from the Stimulus Onset Delay Paradigm

    Science.gov (United States)

    Luke, Steven G.; Nuthmann, Antje; Henderson, John M.

    2013-01-01

    The present study used the stimulus onset delay paradigm to investigate eye movement control in reading and in scene viewing in a within-participants design. Short onset delays (0, 25, 50, 200, and 350 ms) were chosen to simulate the type of natural processing difficulty encountered in reading and scene viewing. Fixation duration increased…

  17. Rhythm perception and production predict reading abilities in developmental dyslexia

    Directory of Open Access Journals (Sweden)

    Elena eFlaugnacco

    2014-06-01

    Full Text Available Rhythm organizes events in time and plays a major role in music, but also in the phonology and prosody of a language. Interestingly, children with developmental dyslexia - a learning disability that affects reading acquisition despite normal intelligence and adequate education - have a poor rhythmic perception. It has been suggested that an accurate perception of rhythmical/metrical structure, that requires accurate perception of rise time, may be critical for phonological development and subsequent literacy. This hypothesis is mostly based on results showing a high degree of correlation between phonological awareness and metrical skills, using a very specific metrical task. We present new findings from the analysis of a sample of 48 children with a diagnosis of dyslexia, without comorbidities. These children were assessed with neuropsychological tests, as well as specifically-devised psychoacoustic and musical tasks mostly testing temporal abilities. Associations were tested by multivariate analyses including data mining strategies, correlations and most importantly logistic regressions to understand to what extent the different auditory and musical skills can be a robust predictor of reading and phonological skills. Results show a strong link between several temporal skills and phonological and reading abilities. These findings are discussed in the framework of the neuroscience literature comparing music and language processing, with a particular interest in the links between rhythm processing in music and language.

  18. Individual Differences in Accurately Judging Personality From Text.

    Science.gov (United States)

    Hall, Judith A; Goh, Jin X; Mast, Marianne Schmid; Hagedorn, Christian

    2016-08-01

    This research examines correlates of accuracy in judging Big Five traits from first-person text excerpts. Participants in six studies were recruited from psychology courses or online. In each study, participants performed a task of judging personality from text and performed other ability tasks and/or filled out questionnaires. Participants who were more accurate in judging personality from text were more likely to be female; had personalities that were more agreeable, conscientious, and feminine, and less neurotic and dominant (all controlling for participant gender); scored higher on empathic concern; self-reported more interest in, and attentiveness to, people's personalities in their daily lives; and reported reading more for pleasure, especially fiction. Accuracy was not associated with SAT scores but had a significant relation to vocabulary knowledge. Accuracy did not correlate with tests of judging personality and emotion based on audiovisual cues. This research is the first to address individual differences in accurate judgment of personality from text, thus adding to the literature on correlates of the good judge of personality. © 2015 Wiley Periodicals, Inc.

  19. Reading comprehension and reading related abilities in adolescents with reading disabilities and attention-deficit/hyperactivity disorder.

    Science.gov (United States)

    Ghelani, Karen; Sidhu, Robindra; Jain, Umesh; Tannock, Rosemary

    2004-11-01

    Reading comprehension is a very complex task that requires different cognitive processes and reading abilities over the life span. There are fewer studies of reading comprehension relative to investigations of word reading abilities. Reading comprehension difficulties, however, have been identified in two common and frequently overlapping childhood disorders: reading disability (RD) and attention-deficit/hyperactivity disorder (ADHD). The nature of reading comprehension difficulties in these groups remains unclear. The performance of four groups of adolescents (RD, ADHD, comorbid ADHD and RD, and normal controls) was compared on reading comprehension tasks as well as on reading rate and accuracy tasks. Adolescents with RD showed difficulties across most reading tasks, although their comprehension scores were average. Adolescents with ADHD exhibited adequate single word reading abilities. Subtle difficulties were observed, however, on measures of text reading rate and accuracy as well as on silent reading comprehension, but scores remained in the average range. The comorbid group demonstrated similar difficulties to the RD group on word reading accuracy and on reading rate but experienced problems on only silent reading comprehension. Implications for reading interventions are outlined, as well as the clinical relevance for diagnosis.

  20. The Explicit Instruction of Reading Strategies: Directed Reading Thinking Activity vs. Guided Reading Strategies

    Directory of Open Access Journals (Sweden)

    Mohammad Mehdi Yazdani

    2015-05-01

    Full Text Available Investigating the efficiencies and deficiencies of reading strategies is one of the noticeable issues in the related theory and research in reading comprehension instruction. This study was to examine the impact of Directed Reading Thinking Activity (DRTA and Guided Reading (GR on reading comprehension. Sixty three Iranian students of grade one in Shahed high school in the city of Bojnourd took part in the study. They were assigned in three groups, one control and two experimental groups. The instruction lasted for ten weeks. This study utilized a pretest posttest control group in quantitative quasi- experimental design. The same reading comprehension test was administered as pre-test and post-test. The results were twofold: First, the instruction of learning strategies could foster reading comprehension skill. Second, while the explicit instruction of both strategies could improve the students' reading comprehension skill, Directed Reading Thinking Activity had a more significant positive effect than Guided Reading.

  1. Shallow and deep orthographies in Hebrew: the role of vowelization in reading development for unvowelized scripts.

    Science.gov (United States)

    Schiff, Rachel

    2012-12-01

    The present study explored the speed, accuracy, and reading comprehension of vowelized versus unvowelized scripts among 126 native Hebrew speaking children in second, fourth, and sixth grades. Findings indicated that second graders read and comprehended vowelized scripts significantly more accurately and more quickly than unvowelized scripts, whereas among fourth and sixth graders reading of unvowelized scripts developed to a greater degree than the reading of vowelized scripts. An analysis of the mediation effect for children's mastery of vowelized reading speed and accuracy on their mastery of unvowelized reading speed and comprehension revealed that in second grade, reading accuracy of vowelized words mediated the reading speed and comprehension of unvowelized scripts. In the fourth grade, accuracy in reading both vowelized and unvowelized words mediated the reading speed and comprehension of unvowelized scripts. By sixth grade, accuracy in reading vowelized words offered no mediating effect, either on reading speed or comprehension of unvowelized scripts. The current outcomes thus suggest that young Hebrew readers undergo a scaffolding process, where vowelization serves as the foundation for building initial reading abilities and is essential for successful and meaningful decoding of unvowelized scripts.

  2. Tackling the ‘dyslexia paradox’: reading brain and behavior for early markers of developmental dyslexia

    Science.gov (United States)

    Ozernov-Palchik, Ola; Gaab, Nadine

    2016-01-01

    Developmental dyslexia is an unexplained inability to acquire accurate or fluent reading that affects approximately 5–17% of children. Dyslexia is associated with structural and functional alterations in various brain regions that support reading. Neuroimaging studies in infants and pre-reading children suggest that these alterations predate reading instruction and reading failure, supporting the hypothesis that variant function in dyslexia susceptibility genes lead to atypical neural migration and/or axonal growth during early, most likely in utero, brain development. Yet, dyslexia is typically not diagnosed until a child has failed to learn to read as expected (usually in second grade or later). There is emerging evidence that neuroimaging measures, when combined with key behavioral measures, can enhance the accuracy of identification of dyslexia risk in prereading children but its sensitivity, specificity, and cost-efficiency is still unclear. Early identification of dyslexia risk carries important implications for dyslexia remediation and the amelioration of the psychosocial consequences commonly associated with reading failure. PMID:26836227

  3. Developmental Relations Between Reading Comprehension and Reading Strategies

    NARCIS (Netherlands)

    Muijselaar, M.; Swart, N.M.; Steenbeek-Planting, E.G,.; Droop, M.; Verhoeven, L.; de Jong, P.F.

    2017-01-01

    We examined the developmental relations between knowledge of reading strategies and reading comprehension in a longitudinal study of 312 Dutch children from the beginning of fourth grade to the end of fifth grade. Measures for reading comprehension, reading strategies, reading fluency, vocabulary,

  4. Forecasting Reading Anxiety for Promoting English-Language Reading Performance Based on Reading Annotation Behavior

    Science.gov (United States)

    Chen, Chih-Ming; Wang, Jung-Ying; Chen, Yong-Ting; Wu, Jhih-Hao

    2016-01-01

    To reduce effectively the reading anxiety of learners while reading English articles, a C4.5 decision tree, a widely used data mining technique, was used to develop a personalized reading anxiety prediction model (PRAPM) based on individual learners' reading annotation behavior in a collaborative digital reading annotation system (CDRAS). In…

  5. Exploring Content Schemata Influence on L2 Reading: "The Hunted Fox" and "Twelve and Not Stupid"

    Science.gov (United States)

    Radzi, Amizura Hanadi Mohd; Aziz, Noor Hashima Abd

    2014-01-01

    This paper will discuss the aspects of content schemata in second language reading among diploma level students who were taking a reading course in Universiti Teknologi MARA Perlis. In this qualitative case study, the researcher had selected two short stories that are categorized as content-familiar texts, i.e. "The Hunted Fox" and…

  6. Longitudinal models of reading achievement of students with learning disabilities and without disabilities.

    Science.gov (United States)

    Sullivan, Amanda L; Kohli, Nidhi; Farnsworth, Elyse M; Sadeh, Shanna; Jones, Leila

    2017-09-01

    Accurate estimation of developmental trajectories can inform instruction and intervention. We compared the fit of linear, quadratic, and piecewise mixed-effects models of reading development among students with learning disabilities relative to their typically developing peers. We drew an analytic sample of 1,990 students from the nationally representative Early Childhood Longitudinal Study-Kindergarten Cohort of 1998, using reading achievement scores from kindergarten through eighth grade to estimate three models of students' reading growth. The piecewise mixed-effects models provided the best functional form of the students' reading trajectories as indicated by model fit indices. Results showed slightly different trajectories between students with learning disabilities and without disabilities, with varying but divergent rates of growth throughout elementary grades, as well as an increasing gap over time. These results highlight the need for additional research on appropriate methods for modeling reading trajectories and the implications for students' response to instruction. (PsycINFO Database Record (c) 2017 APA, all rights reserved).

  7. An accurate and efficient identification of children with psychosocial problems by means of computerized adaptive testing

    NARCIS (Netherlands)

    Vogels, Antonius G. C.; Jacobusse, Gert W.; Reijneveld, Symen A.

    2011-01-01

    Background: Questionnaires used by health services to identify children with psychosocial problems are often rather short. The psychometric properties of such short questionnaires are mostly less than needed for an accurate distinction between children with and without problems. We aimed to assess

  8. Reading and visual search: a developmental study in normal children.

    Directory of Open Access Journals (Sweden)

    Magali Seassau

    Full Text Available Studies dealing with developmental aspects of binocular eye movement behaviour during reading are scarce. In this study we have explored binocular strategies during reading and during visual search tasks in a large population of normal young readers. Binocular eye movements were recorded using an infrared video-oculography system in sixty-nine children (aged 6 to 15 and in a group of 10 adults (aged 24 to 39. The main findings are (i in both tasks the number of progressive saccades (to the right and regressive saccades (to the left decreases with age; (ii the amplitude of progressive saccades increases with age in the reading task only; (iii in both tasks, the duration of fixations as well as the total duration of the task decreases with age; (iv in both tasks, the amplitude of disconjugacy recorded during and after the saccades decreases with age; (v children are significantly more accurate in reading than in visual search after 10 years of age. Data reported here confirms and expands previous studies on children's reading. The new finding is that younger children show poorer coordination than adults, both while reading and while performing a visual search task. Both reading skills and binocular saccades coordination improve with age and children reach a similar level to adults after the age of 10. This finding is most likely related to the fact that learning mechanisms responsible for saccade yoking develop during childhood until adolescence.

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

  10. Child-centered reading intervention: See, talk, dictate, read, write!

    Directory of Open Access Journals (Sweden)

    Muhammet BAŞTUĞ

    2016-06-01

    Full Text Available Poor reading achievement of children in elementary schools has been one of the major concerns in education. The aim of this study is to examine the effectiveness of a child-centered reading intervention in eliminating the reading problems of a student with poor reading achievement. The research was conducted with a student having difficulty in reading. A reading intervention was designed that targeted multiple areas of reading and aimed to improve reading skills through the use of multiple strategies. This intervention is child-centered and includes visual aids, talking, dictating, reading and writing stages. The study was performed in 35 sessions consisting of stages of a single sentence (5 sessions, two sentences (5 sessions, three sentences (20 sessions and the text stage (5 sessions. The intervention sessions were audio-taped. These recordings and the written responses to the reading comprehension questions provided the data for analysis. The findings on the reading intervention revealed positive outcomes. The student exhibited certain improvements at the levels of reading, reading rate and reading comprehension. These results were discussed in the literature and the findings suggest that child-centered reading strategies such as talking, dictating and writing should be the main focus of instruction for students with low reading literacy achievement to enable these students to meet the demands of the curriculum.

  11. TagDust2: a generic method to extract reads from sequencing data.

    Science.gov (United States)

    Lassmann, Timo

    2015-01-28

    Arguably the most basic step in the analysis of next generation sequencing data (NGS) involves the extraction of mappable reads from the raw reads produced by sequencing instruments. The presence of barcodes, adaptors and artifacts subject to sequencing errors makes this step non-trivial. Here I present TagDust2, a generic approach utilizing a library of hidden Markov models (HMM) to accurately extract reads from a wide array of possible read architectures. TagDust2 extracts more reads of higher quality compared to other approaches. Processing of multiplexed single, paired end and libraries containing unique molecular identifiers is fully supported. Two additional post processing steps are included to exclude known contaminants and filter out low complexity sequences. Finally, TagDust2 can automatically detect the library type of sequenced data from a predefined selection. Taken together TagDust2 is a feature rich, flexible and adaptive solution to go from raw to mappable NGS reads in a single step. The ability to recognize and record the contents of raw reads will help to automate and demystify the initial, and often poorly documented, steps in NGS data analysis pipelines. TagDust2 is freely available at: http://tagdust.sourceforge.net .

  12. Orthographic Transparency Enhances Morphological Segmentation in Children Reading Hebrew Words

    Science.gov (United States)

    Haddad, Laurice; Weiss, Yael; Katzir, Tami; Bitan, Tali

    2018-01-01

    Morphological processing of derived words develops simultaneously with reading acquisition. However, the reader’s engagement in morphological segmentation may depend on the language morphological richness and orthographic transparency, and the readers’ reading skills. The current study tested the common idea that morphological segmentation is enhanced in non-transparent orthographies to compensate for the absence of phonological information. Hebrew’s rich morphology and the dual version of the Hebrew script (with and without diacritic marks) provides an opportunity to study the interaction of orthographic transparency and morphological segmentation on the development of reading skills in a within-language design. Hebrew speaking 2nd (N = 27) and 5th (N = 29) grade children read aloud 96 noun words. Half of the words were simple mono-morphemic words and half were bi-morphemic derivations composed of a productive root and a morphemic pattern. In each list half of the words were presented in the transparent version of the script (with diacritic marks), and half in the non-transparent version (without diacritic marks). Our results show that in both groups, derived bi-morphemic words were identified more accurately than mono-morphemic words, but only for the transparent, pointed, script. For the un-pointed script the reverse was found, namely, that bi-morphemic words were read less accurately than mono-morphemic words, especially in second grade. Second grade children also read mono-morphemic words faster than bi-morphemic words. Finally, correlations with a standardized measure of morphological awareness were found only for second grade children, and only in bi-morphemic words. These results, showing greater morphological effects in second grade compared to fifth grade children suggest that for children raised in a language with a rich morphology, common and easily segmented morphemic units may be more beneficial for younger compared to older readers. Moreover

  13. Orthographic Transparency Enhances Morphological Segmentation in Children Reading Hebrew Words

    Directory of Open Access Journals (Sweden)

    Laurice Haddad

    2018-01-01

    Full Text Available Morphological processing of derived words develops simultaneously with reading acquisition. However, the reader’s engagement in morphological segmentation may depend on the language morphological richness and orthographic transparency, and the readers’ reading skills. The current study tested the common idea that morphological segmentation is enhanced in non-transparent orthographies to compensate for the absence of phonological information. Hebrew’s rich morphology and the dual version of the Hebrew script (with and without diacritic marks provides an opportunity to study the interaction of orthographic transparency and morphological segmentation on the development of reading skills in a within-language design. Hebrew speaking 2nd (N = 27 and 5th (N = 29 grade children read aloud 96 noun words. Half of the words were simple mono-morphemic words and half were bi-morphemic derivations composed of a productive root and a morphemic pattern. In each list half of the words were presented in the transparent version of the script (with diacritic marks, and half in the non-transparent version (without diacritic marks. Our results show that in both groups, derived bi-morphemic words were identified more accurately than mono-morphemic words, but only for the transparent, pointed, script. For the un-pointed script the reverse was found, namely, that bi-morphemic words were read less accurately than mono-morphemic words, especially in second grade. Second grade children also read mono-morphemic words faster than bi-morphemic words. Finally, correlations with a standardized measure of morphological awareness were found only for second grade children, and only in bi-morphemic words. These results, showing greater morphological effects in second grade compared to fifth grade children suggest that for children raised in a language with a rich morphology, common and easily segmented morphemic units may be more beneficial for younger compared to older

  14. IMPROVING STUDENTS’ READING COMPREHENSION THROUGH IINTERACTIVE READ-ALOUD TECHNIQUE

    Directory of Open Access Journals (Sweden)

    Edi Santoso

    2015-10-01

    Full Text Available Abstract: The present study, entitled Improving Students’ Reading Comprehension through Interactive Read-Aloud, attempts to unlock problems found in teaching and reading comprehension through interactive read-aloud in a Senior High School of Sport (SMAN Olah Raga Lampung, in Metro. The findings revealed that students’ reading comprehension improved through interactive read-aloud. The improvement can be seen from the increase of test results, meaning construction, and motivation. The process of reading activities showed that the teacher’s gesture and body language, 20 questions, explain and guess activities were proven to help the students construct meaning from the given texts. In addition, interactive read-aloud is effective to boost students’ motivation to comprehend the texts.   Key words: Reading comprehension, interactive read-aloud.

  15. Reading faster

    Directory of Open Access Journals (Sweden)

    Paul Nation

    2009-12-01

    Full Text Available This article describes the visual nature of the reading process as it relates to reading speed. It points out that there is a physical limit on normal reading speed and beyond this limit the reading process will be different from normal reading where almost every word is attended to. The article describes a range of activities for developing reading fluency, and suggests how the development of fluency can become part of a reading programme.

  16. Incorporating Computers into Classroom: Effects on Learners’ Reading Comprehension in EFL Context

    Directory of Open Access Journals (Sweden)

    Ali Akbar Ansarin

    2017-10-01

    Full Text Available Owing to the importance of computer-assisted reading and considering the prominent role of learners in this respect, the present study investigated: (1 the effects of computer as a supplemental tool to support and improve the Iranian EFL learners’ reading comprehension in comparison with equivalent non-technological or traditional print-based treatments, (2 EFL learners’ attitudes and perception towards the computer-assisted reading course.To this purpose, 111 randomly selected groups of EFL learners participated in the study. The subjects were divided into two groups of control and experimental. Both groups received 10 reading lessons either through computers or through an instructor-led method. The statistical analysis revealed no significant difference between the learners who had access to reading supports on computer screen and their counterparts in the traditional reading classes. Learners were also allowed to express their ideas on a 5-point Likert Scale. The purpose of the attitude questionnaire was to find out more information about the participants and their experiences with computer-assisted reading. Results of attitude questionnaire supported the conclusion that computers may enhance EFL learners’ motivation and interest towards learning but they do not enhance comprehension. The findings of this study support the view that technology should supplement not supplant teachers and that people read less accurately and less comprehensively on screens than on paper.

  17. Extensive Graded Reading in the Liberal Arts and Sciences

    Science.gov (United States)

    Poulshock, Joseph

    2010-01-01

    For this research, learners did extensive graded reading (EGR) with traditional graded readers, and they also interacted with short graded stories in the liberal arts and sciences (LAS). This study describes the purpose and format of the LAS stories used by hundreds of university students and adult learners in Japan. It summarizes the results of…

  18. A Case Study of Two College Students’ Reading Strategies and Their Writing Styles

    Directory of Open Access Journals (Sweden)

    Zhanfang Li

    2016-07-01

    Full Text Available The importance of integrating reading and writing has aroused many people’s interest, and how to bridge the gap between input (reading and output (writing is regarded as an urgent necessity. However, input does not equal to intake, and to achieve the stage of intake, the reader’s conscious attention to the input is necessary, which is commonly realized in the reading process, either by intensive reading (focus-on-form or extensive reading (focus-on-meaning. Previous studies put more emphasis on extensive reading, while this study is based on the assumed different effects of reading strategies upon writing styles, that is, intensive reading may guarantee accurate writing and extensive reading may promote fluent writing. Therefore the relationship between two college students’ reading strategies and writing styles is the focus of this study. The research lasts for 16 months (August, 2014 - December, 2015, during which all their journal writing pieces, their term papers, together with their compositions in the final exams, are used as the written data, while materials concerned with their reading strategies are collected by a questionnaire, two interviews, as well as their written self-reflections. Results show that extensive reading with a subconscious focus-on-meaning tends to enhance the fluency of writing while intensive reading with a conscious focus-on-form is more likely to promote the writing accuracy. Findings suggest that production is based on intake, which is the result of either the subconscious or conscious attention to both the language meaning and language form.

  19. Promoting preschool reading

    OpenAIRE

    Istenič, Vesna

    2013-01-01

    The thesis titled Promoting preschool reading consists of a theoretiral and an empirical part. In the theoretical part I wrote about reading, the importance of reading, types of reading, about reading motivation, promoting reading motivation, internal and external motivation, influence of reading motivation on the child's reading activity, reading and familial literacy, the role of adults in promotion reading literacy, reading to a child and promoting reading in pre-school years, where I ...

  20. Rapid Multiplex Small DNA Sequencing on the MinION Nanopore Sequencing Platform

    Directory of Open Access Journals (Sweden)

    Shan Wei

    2018-05-01

    Full Text Available Real-time sequencing of short DNA reads has a wide variety of clinical and research applications including screening for mutations, target sequences and aneuploidy. We recently demonstrated that MinION, a nanopore-based DNA sequencing device the size of a USB drive, could be used for short-read DNA sequencing. In this study, an ultra-rapid multiplex library preparation and sequencing method for the MinION is presented and applied to accurately test normal diploid and aneuploidy samples’ genomic DNA in under three hours, including library preparation and sequencing. This novel method shows great promise as a clinical diagnostic test for applications requiring rapid short-read DNA sequencing.

  1. Audio-visual synchronization in reading while listening to texts: Effects on visual behavior and verbal learning

    OpenAIRE

    Gerbier , Emilie; Bailly , Gérard; Bosse , Marie-Line

    2018-01-01

    International audience; Reading while listening to texts (RWL) is a promising way to improve the learning benefits provided by a reading experience. In an exploratory study, we investigated the effect of synchronizing the highlighting of words (visual) with their auditory (speech) counterpart during a RWL task. Forty French children from 3rd to 5th grade read short stories in their native language while hearing the story spoken by a narrator. In the non-synchronized (S-) condition the text wa...

  2. Short interval expansion of Rényi entropy on torus

    Energy Technology Data Exchange (ETDEWEB)

    Chen, Bin [Department of Physics and State Key Laboratory of Nuclear Physics and Technology,Peking University,5 Yiheyuan Rd, Beijing 100871 (China); Collaborative Innovation Center of Quantum Matter,5 Yiheyuan Rd, Beijing 100871 (China); Center for High Energy Physics, Peking University,5 Yiheyuan Rd, Beijing 100871 (China); Wu, Jun-Bao [Theoretical Physics Division, Institute of High Energy Physics, Chinese Academy of Sciences,19B Yuquan Rd, Beijing 100049 (China); Theoretical Physics Center for Science Facilities, Chinese Academy of Sciences,19B Yuquan Rd, Beijing 100049 (China); Center for High Energy Physics, Peking University,5 Yiheyuan Rd, Beijing 100871 (China); Zhang, Jia-ju [Theoretical Physics Division, Institute of High Energy Physics, Chinese Academy of Sciences,19B Yuquan Rd, Beijing 100049 (China); Theoretical Physics Center for Science Facilities, Chinese Academy of Sciences,19B Yuquan Rd, Beijing 100049 (China)

    2016-08-23

    We investigate the short interval expansion of the Rényi entropy for two-dimensional conformal field theory (CFT) on a torus. We require the length of the interval ℓ to be small with respect to the spatial and temporal sizes of the torus. The operator product expansion of the twist operators allows us to compute the short interval expansion of the Rényi entropy at any temperature. In particular, we pay special attention to the large c CFTs dual to the AdS{sub 3} gravity and its cousins. At both low and high temperature limits, we read the Rényi entropies to order ℓ{sup 6}, and find good agreements with holographic results. Moreover, the expansion allows us to read 1/c contribution, which is hard to get by expanding the thermal density matrix. We generalize the study to the case with the chemical potential as well.

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

  4. Web-based diagnosis and therapy of auditory prerequisites for reading and spelling

    Directory of Open Access Journals (Sweden)

    Krammer, Sandra

    2006-11-01

    Full Text Available Cognitive deficits in auditory or visual processing or in verbal short-term-memory are amongst others risk factors for the development of dyslexia (reading and spelling disability. By early identification and intervention (optimally before school entry, detrimental effects of these cognitive deficits on reading and spelling might be prevented. The goal of the CASPAR-project is to develop and evaluate web-based tools for diagnosis and therapy of cognitive prerequisites for reading and spelling, which are appropriate for kindergarten children. In the first approach CASPAR addresses auditory processing disorders. This article describes a computerized and web-based approach for screening and testing phoneme discrimination and for promoting phoneme discrimination abilities through interactive games in kindergarteners.

  5. Parents' reading-related knowledge and children's reading acquisition.

    Science.gov (United States)

    Ladd, Megan; Martin-Chang, Sandra; Levesque, Kyle

    2011-12-01

    Teacher reading-related knowledge (phonological awareness and phonics knowledge) predicts student reading, however little is known about the reading-related knowledge of parents. Participants comprised 70 dyads (children from kindergarten and grade 1 and their parents). Parents were administered a questionnaire tapping into reading-related knowledge, print exposure, storybook reading, and general cultural knowledge. Children were tested on measures of letter-word knowledge, sound awareness, receptive vocabulary, oral expression, and mathematical skill. Parent reading-related knowledge showed significant positive links with child letter-word knowledge and sound awareness, but showed no correlations with child measures of mathematical skill or vocabulary. Furthermore, parent reading-related knowledge was not associated with parents' own print exposure or cultural knowledge, indicating that knowledge about English word structure may be separate from other cognitive skills. Implications are discussed in terms of improving parent reading-related knowledge to promote child literacy.

  6. Role of executive functioning and home environment in early reading development

    NARCIS (Netherlands)

    Segers, P.C.J.; Damhuis, C.M.P.; Sande, E. van de; Verhoeven, L.T.W.

    2016-01-01

    We examined the role of executive functioning (EF) and home environment in the prediction of early reading development. In a longitudinal design, we followed 101 Dutch children from kindergarten to second grade. EF (attentional control, action control, short-term memory (STM)) and home factors

  7. Why should I read? - A cross-cultural investigation into adolescents' reading socialisation and reading attitude

    Science.gov (United States)

    Broeder, Peter; Stokmans, Mia

    2013-06-01

    While reading behaviour of adolescents is a frequent object of research, most studies in this field are restricted to a single country. This study investigates reading as a leisure-time activity across social groups from three regions differing in reading tradition as well as in the facilities available for reading. The authors analyse the reading behaviour of a total of 2,173 adolescents in the Netherlands, in Beijing (China), and in Cape Town (South Africa). Taking Icek Ajzen's Theory of Planned Behaviour as a starting point, the authors adjusted it to model the three most important determinants of reading behaviour, namely (1) reading attitude; (2) subjective norms (implicit and explicit social pressure to read); and (3) perceived behavioural control, which includes reading proficiency and appropriateness of the available books (book supply). While they found the adjusted model to fit the Dutch and Beijing situation quite well, it appeared to be inappropriate for the Cape Town situation. Despite considerable cultural and situational differences between the Netherlands and Beijing, the results show a similar pattern for these two environments. The most important determinants turn out to be: the hedonic reading attitude, the implicit norm of family and friends, the attractiveness of the available choice of books, and the perceived reading proficiency.

  8. Short-term memory load and pronunciation rate

    Science.gov (United States)

    Schweickert, Richard; Hayt, Cathrin

    1988-01-01

    In a test of short-term memory recall, two subjects attempted to recall various lists. For unpracticed subjects, the time it took to read the list is a better predictor of immediate recall than the number of items on the list. For practiced subjects, the two predictors do about equally well. If the items that must be recalled are unfamiliar, it is advantageous to keep the items short to pronounce. On the other hand, if the same items will be encountered over and over again, it is advantageous to make them distinctive, even at the cost of adding to the number of syllables.

  9. Reading Function and Content Words in Subtitled Videos

    Science.gov (United States)

    Szarkowska, Agnieszka; Łogińska, Maria

    2016-01-01

    In this study, we examined how function and content words are read in intra- and interlingual subtitles. We monitored eye movements of a group of 39 deaf, 27 hard of hearing, and 56 hearing Polish participants while they viewed English and Polish videos with Polish subtitles. We found that function words and short content words received less visual attention than longer content words, which was reflected in shorter dwell time, lower number of fixations, shorter first fixation duration, and lower subject hit count. Deaf participants dwelled significantly longer on function words than other participants, which may be an indication of their difficulty in processing this type of words. The findings are discussed in the context of classical reading research and applied research on subtitling. PMID:26681268

  10. Real-time energy resources scheduling considering short-term and very short-term wind forecast

    Energy Technology Data Exchange (ETDEWEB)

    Silva, Marco; Sousa, Tiago; Morais, Hugo; Vale, Zita [Polytechnic of Porto (Portugal). GECAD - Knowledge Engineering and Decision Support Research Center

    2012-07-01

    This paper proposes an energy resources management methodology based on three distinct time horizons: day-ahead scheduling, hour-ahead scheduling, and real-time scheduling. In each scheduling process the update of generation and consumption operation and of the storage and electric vehicles storage status are used. Besides the new operation conditions, the most accurate forecast values of wind generation and of consumption using results of short-term and very short-term methods are used. A case study considering a distribution network with intensive use of distributed generation and electric vehicles is presented. (orig.)

  11. Comparison of reading speed with 3 different log-scaled reading charts.

    Science.gov (United States)

    Buari, Noor Halilah; Chen, Ai-Hong; Musa, Nuraini

    2014-01-01

    A reading chart that resembles real reading conditions is important to evaluate the quality of life in terms of reading performance. The purpose of this study was to compare the reading speed of UiTM Malay related words (UiTM-Mrw) reading chart with MNread Acuity Chart and Colenbrander Reading Chart. Fifty subjects with normal sight were randomly recruited through randomized sampling in this study (mean age=22.98±1.65 years). Subjects were asked to read three different near charts aloud and as quickly as possible at random sequence. The charts were the UiTM-Mrw Reading Chart, MNread Acuity Chart and Colenbrander Reading Chart, respectively. The time taken to read each chart was recorded and any errors while reading were noted. Reading performance was quantified in terms of reading speed as words per minute (wpm). The mean reading speed for UiTM-Mrw Reading Chart, MNread Acuity Chart and Colenbrander Reading Chart was 200±30wpm, 196±28wpm and 194±31wpm, respectively. Comparison of reading speed between UiTM-Mrw Reading Chart and MNread Acuity Chart showed no significant difference (t=-0.73, p=0.72). The same happened with the reading speed between UiTM-Mrw Reading Chart and Colenbrander Reading Chart (t=-0.97, p=0.55). Bland and Altman plot showed good agreement between reading speed of UiTM-Mrw Reading Chart with MNread Acuity Chart with the Colenbrander Reading Chart. UiTM-Mrw Reading Chart in Malay language is highly comparable with standardized charts and can be used for evaluating reading speed. Copyright © 2013 Spanish General Council of Optometry. Published by Elsevier Espana. All rights reserved.

  12. Reading Comprehension in Boys with ADHD: The Mediating Roles of Working Memory and Orthographic Conversion.

    Science.gov (United States)

    Friedman, Lauren M; Rapport, Mark D; Raiker, Joseph S; Orban, Sarah A; Eckrich, Samuel J

    2017-02-01

    Reading comprehension difficulties in children with ADHD are well established; however, limited information exists concerning the cognitive mechanisms that contribute to these difficulties and the extent to which they interact with one another. The current study examines two broad cognitive processes known to be involved in children's reading comprehension abilities-(a) working memory (i.e., central executive processes [CE], phonological short-term memory [PH STM], and visuospatial short-term memory [VS STM]) and (b) orthographic conversion (i.e., conversion of visually presented text to a phonological code)-to elucidate their unique and interactive contribution to ADHD-related reading comprehension differences. Thirty-one boys with ADHD-combined type and 30 typically developing (TD) boys aged 8 to 12 years (M = 9.64, SD = 1.22) were administered multiple counterbalanced tasks assessing WM and orthographic conversion processes. Relative to TD boys, boys with ADHD exhibited significant deficits in PH STM (d = -0.70), VS STM (d = -0.92), CE (d = -1.58), and orthographic conversion (d = -0.93). Bias-corrected, bootstrapped mediation analyses revealed that CE and orthographic conversion processes modeled separately mediated ADHD-related reading comprehension differences partially, whereas PH STM and VS STM did not. CE and orthographic conversion modeled jointly mediated ADHD-related reading comprehension differences fully wherein orthographic conversion's large magnitude influence on reading comprehension occurred indirectly through CE's impact on the orthographic system. The findings suggest that adaptive cognitive interventions designed to improve reading-related outcomes in children with ADHD may benefit by including modules that train CE and orthographic conversion processes independently and interactively.

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

  14. Lexical inference as an obstacle to reading comprehension at senior ...

    African Journals Online (AJOL)

    The first utilised twenty-five Multiple Choice questions to test vocabulary out of context. Before the students attempted the second test they read three different passages of text after which they were tested on the same vocabulary items as in Test 1. They also answered twenty-five Short Answer comprehension questions ...

  15. ConDeTri--a content dependent read trimmer for Illumina data.

    Science.gov (United States)

    Smeds, Linnéa; Künstner, Axel

    2011-01-01

    During the last few years, DNA and RNA sequencing have started to play an increasingly important role in biological and medical applications, especially due to the greater amount of sequencing data yielded from the new sequencing machines and the enormous decrease in sequencing costs. Particularly, Illumina/Solexa sequencing has had an increasing impact on gathering data from model and non-model organisms. However, accurate and easy to use tools for quality filtering have not yet been established. We present ConDeTri, a method for content dependent read trimming for next generation sequencing data using quality scores of each individual base. The main focus of the method is to remove sequencing errors from reads so that sequencing reads can be standardized. Another aspect of the method is to incorporate read trimming in next-generation sequencing data processing and analysis pipelines. It can process single-end and paired-end sequence data of arbitrary length and it is independent from sequencing coverage and user interaction. ConDeTri is able to trim and remove reads with low quality scores to save computational time and memory usage during de novo assemblies. Low coverage or large genome sequencing projects will especially gain from trimming reads. The method can easily be incorporated into preprocessing and analysis pipelines for Illumina data. Freely available on the web at http://code.google.com/p/condetri.

  16. Strategies identification in an experimental reading comprehension task

    Directory of Open Access Journals (Sweden)

    Stanković Sanda

    2010-01-01

    Full Text Available Standardized reading comprehension tests (RCTs usually consist of a small number of texts each accompanied by several multiple-choice questions, with texts and questions simultaneously presented. The score the common measure of reading comprehension ability in RCTs is the score. Literature review suggests that strategies subjects employ may influence their performance on RCT, however the score itself provides no information on the specific strategy employed. Knowledge of test-taking strategies could have impact on understanding of the actual purpose and benefits of using RCTs in pedagogical and psychological practice. With the ultimate objective of constructing a first standard RCT in Serbian language, the preliminary step we took was to conduct an experimental reading comprehension task (ERCT consisting of 27 short texts displayed in succession, each followed by a single multiplechoice question. Using qualitative analysis of subjects’ responses in semi-structured postexperimental interview, we identified four overall strategies used on ERCT. Our results show that groups of students who used specific strategies differed significantly from one another in text reading time, with no differences found regarding the question reading and answering time. More importantly, there were no significant between-group differences found in terms of ERCT score. These findings suggest that choice of strategy is a way to optimize the relation between one’s own potential and ERCT task requirements. RCT based on ERCT principles would allow for a flexible choice of strategy which would not influence the final score.

  17. Word skipping: effects of word length, predictability, spelling and reading skill.

    Science.gov (United States)

    Slattery, Timothy J; Yates, Mark

    2017-08-31

    Readers eyes often skip over words as they read. Skipping rates are largely determined by word length; short words are skipped more than long words. However, the predictability of a word in context also impacts skipping rates. Rayner, Slattery, Drieghe and Liversedge (2011) reported an effect of predictability on word skipping for even long words (10-13 characters) that extend beyond the word identification span. Recent research suggests that better readers and spellers have an enhanced perceptual span (Veldre & Andrews, 2014). We explored whether reading and spelling skill interact with word length and predictability to impact word skipping rates in a large sample (N=92) of average and poor adult readers. Participants read the items from Rayner et al. (2011) while their eye movements were recorded. Spelling skill (zSpell) was assessed using the dictation and recognition tasks developed by Sally Andrews and colleagues. Reading skill (zRead) was assessed from reading speed (words per minute) and accuracy of three 120 word passages each with 10 comprehension questions. We fit linear mixed models to the target gaze duration data and generalized linear mixed models to the target word skipping data. Target word gaze durations were significantly predicted by zRead while, the skipping likelihoods were significantly predicted by zSpell. Additionally, for gaze durations, zRead significantly interacted with word predictability as better readers relied less on context to support word processing. These effects are discussed in relation to the lexical quality hypothesis and eye movement models of reading.

  18. Language, reading, and math learning profiles in an epidemiological sample of school age children.

    Science.gov (United States)

    Archibald, Lisa M D; Oram Cardy, Janis; Joanisse, Marc F; Ansari, Daniel

    2013-01-01

    Dyscalculia, dyslexia, and specific language impairment (SLI) are relatively specific developmental learning disabilities in math, reading, and oral language, respectively, that occur in the context of average intellectual capacity and adequate environmental opportunities. Past research has been dominated by studies focused on single impairments despite the widespread recognition that overlapping and comorbid deficits are common. The present study took an epidemiological approach to study the learning profiles of a large school age sample in language, reading, and math. Both general learning profiles reflecting good or poor performance across measures and specific learning profiles involving either weak language, weak reading, weak math, or weak math and reading were observed. These latter four profiles characterized 70% of children with some evidence of a learning disability. Low scores in phonological short-term memory characterized clusters with a language-based weakness whereas low or variable phonological awareness was associated with the reading (but not language-based) weaknesses. The low math only group did not show these phonological deficits. These findings may suggest different etiologies for language-based deficits in language, reading, and math, reading-related impairments in reading and math, and isolated math disabilities.

  19. Language, reading, and math learning profiles in an epidemiological sample of school age children.

    Directory of Open Access Journals (Sweden)

    Lisa M D Archibald

    Full Text Available Dyscalculia, dyslexia, and specific language impairment (SLI are relatively specific developmental learning disabilities in math, reading, and oral language, respectively, that occur in the context of average intellectual capacity and adequate environmental opportunities. Past research has been dominated by studies focused on single impairments despite the widespread recognition that overlapping and comorbid deficits are common. The present study took an epidemiological approach to study the learning profiles of a large school age sample in language, reading, and math. Both general learning profiles reflecting good or poor performance across measures and specific learning profiles involving either weak language, weak reading, weak math, or weak math and reading were observed. These latter four profiles characterized 70% of children with some evidence of a learning disability. Low scores in phonological short-term memory characterized clusters with a language-based weakness whereas low or variable phonological awareness was associated with the reading (but not language-based weaknesses. The low math only group did not show these phonological deficits. These findings may suggest different etiologies for language-based deficits in language, reading, and math, reading-related impairments in reading and math, and isolated math disabilities.

  20. The Effects of Video Self-Modeling on the Decoding Skills of Children At Risk for Reading Disabilities

    OpenAIRE

    Ayala, Sandra M

    2010-01-01

    Ten first grade students, participating in a Tier II response to intervention (RTI) reading program received an intervention of video self modeling to improve decoding skills and sight word recognition. The students were video recorded blending and segmenting decodable words, and reading sight words taken directly from their curriculum instruction. Individual videos were recorded and edited to show students successfully and accurately decoding words and practicing sight word recognition. Each...

  1. The Effects of Extensive Reading on Reading Comprehension, Reading Rate, and Vocabulary Acquisition

    Science.gov (United States)

    Suk, Namhee

    2017-01-01

    Several empirical studies and syntheses of extensive reading have concluded that extensive reading has positive impacts on language learning in second- and foreign-language settings. However, many of the studies contained methodological or curricular limitations, raising questions about the asserted positive effects of extensive reading. The…

  2. Early identification and intervention in children at risk for reading difficulties

    NARCIS (Netherlands)

    Regtvoort, A.G.F.M.

    2014-01-01

    In pre-readers, a familial background of dyslexia and/or delayed emergent literacy should be considered a not-to-ignore risk signalling problems with learning to read. This thesis aims to study early identification and intervention in at-risk children shortly before or after the start of formal

  3. Enhancing academic reading skills through extensive reading ...

    African Journals Online (AJOL)

    Abstract. The current study explores the feasibility of an extensive reading programme in the context of a low-income country (Mozambique), as well as the influence of extensive reading on academic reading. The programme took over 4 months and was conducted among 30 students majoring in Journalism at the Eduardo ...

  4. The Effect of Critical Thinking Skills on Reading English Novels

    Directory of Open Access Journals (Sweden)

    Ashraf Haji Maibodi

    2014-12-01

    Full Text Available This experimental study examined the effect of critical thinking skills on reading English novels and its influence on EFL learners reading proficiency. For the purpose of this study participants in addition to their text book read and received instructions on the unabridged short novels for one semester. Sixty Iranian EFL junior undergraduates participated in this study and were randomly divided to two groups of thirty each. To test the hypothesis, two independent t-tests were conducted to see the difference between the two groups. The results of the study showed that students in group A were more critically oriented than their counterparts in group B. The pedagogical implication of this study suggests that direct instruction in critical thinking has an impact on EFL learners’ reading proficiency. This article is intended to help teachers who are interested in developing and encouraging critical thinking in their language classrooms. EFL learners need to learn how to establish realistic goals, monitor their own learning and reflect and challenge their own attitudes so that they may get closer to the idea of being good language learners. The findings of this study revealed that there was a significant improvement in students’ attitudes, confidence, and interest especially, in their novel-reading ability.

  5. Reading: Time

    NARCIS (Netherlands)

    Annemarie Wennekers; Frank Huysmans; Jos de Haan

    2018-01-01

    Original title: Lees:Tijd The amount of time that Dutch people spend reading has been declining steadily since the 1950s. This decline in reading time contrasts starkly with the positive personal and social benefits that can be derived from reading, according to lots of research. The Reading:

  6. [Development of a training program for Japanese dyslexic children and its short-term efficacy].

    Science.gov (United States)

    Wakamiya, Eiji; Takeshita, Takashi; Nakanishi, Makoto; Mizuta, Mekumi; Kurimoto, Naoko; Okumura, Tomohito; Tamai, Hiroshi; Koeda, Tatsuya; Inagaki, Masumi

    2013-07-01

    The purpose of this study is to develop a computer training program of reading for the Japanese dyslexic children and to examine its short-term efficacy on their reading and writing abilities. Fifteen dyslexic children underwent two sets of training programs, one for single-hiragana and non-word reading, and the other for the reading of real words, in which each hiragana was followed by the correctly read sound. Subjects were required to use a given program for five minutes a day for three weeks, switching to the other program after a three-week interval. Four kinds of reading test and one writing test were done at the beginning and end of each program period. The averages reading speeds increased, and the single-hiragana reading error average was lower after the training. Hiragana-writing errors also decreased, even though no writing procedure was involved in the programs. The results indicate the usefulness of these training programs as an early intervention of reading and writing for the Japanese dyslexic children.

  7. Association of School-Based Physical Activity Opportunities, Socioeconomic Status, and Third-Grade Reading

    Science.gov (United States)

    Kern, Ben D.; Graber, Kim C.; Shen, Sa; Hillman, Charles H.; McLoughlin, Gabriella

    2018-01-01

    Background: Socioeconomic status (SES) is the most accurate predictor of academic performance in US schools. Third-grade reading is highly predictive of high school graduation. Chronic physical activity (PA) is shown to improve cognition and academic performance. We hypothesized that school-based PA opportunities (recess and physical education)…

  8. Dialogic Reading Aloud to Promote Extensive Reading

    Science.gov (United States)

    Jacobs, George M.

    2016-01-01

    How can teachers motivate students to read extensively in a second language? One strategy is for teachers to read aloud to students to promote the joys of reading generally, to build students' language skills and to introduce students to specific authors, book series, genres, websites, etc. This article begins by discussing why teachers might want…

  9. Reading "Daddy's Roommate": Preservice Teachers Respond to a Controversial Text.

    Science.gov (United States)

    Williams, Shawyn

    2002-01-01

    Explores the responses of the author's 31 pre-service teachers to a controversial picture book. Begins by searching for a short text geared to elementary age children and suited for read-alouds. Notes that she believes that the majority of pre-service teachers at this stage in the program are still very impressionable and must be given multiple…

  10. An investigation of Chinese university EFL learner’s foreign language reading anxiety, reading strategy use and reading comprehension performance

    Directory of Open Access Journals (Sweden)

    Zhongshe Lu

    2015-01-01

    Full Text Available The present study explored the interrelations between foreign language (FL reading anxiety, FL reading strategy use and their interactive effect on FL reading comprehension performance at the tertiary level in China. Analyses of the survey data collected from 1702 university students yielded the following results: (a Both Foreign Language Reading Anxiety Scale (FLRAS and Foreign Language Reading Strategy Use Scale (FLRSUS had important subcomponents, (b more than half of the students generally did not feel anxious when reading English, and were confident in and satisfied with their English reading proficiency. Meanwhile, (c more than half of them moderately used different types of reading strategies such as planning, checking and confirming, predicting and assessing, when reading English, (d compared with their female peers, male students felt significantly more anxious when facing reading activities, less satisfied with their English reading proficiency, and used specific analyzing and planning strategies significantly less often during a reading activity, (e FLRAS was significantly inversely related to FLRSUS, and both were significantly correlated with the students’ FL reading comprehension performance, and (f FLRAS (overall FL reading anxiety, FLRAS1 (general anxiety about FL reading, and FLRSUS2 (predicting strategies were good predictors of FL reading comprehension performance. Based on the findings, some implications are discussed.

  11. A Novel Method for Short Distance Measurements

    International Nuclear Information System (INIS)

    Fernandez, M.G.; Ferrando, A.; Josa, M.I.; Molinero, A.; Oller, J.C.; Arce, P.; Calvo, E.; Figueroa, C.F.; Garcia, C.F.; Rodigrido, T.; Vila, I.; Virto, A.L.

    1998-01-01

    A new, accurate and un expensive device for measuring short distances, intended for monitoring in LHC experiments is presented. Data taken with a very simple prototype are shown and performance is extracted. (Author) 4 refs

  12. The Habit of Reading: A Neglected Dimension of Adult Reading Instruction.

    Science.gov (United States)

    Fink, Katherine T.; Devine, Thomas G.

    1993-01-01

    Less competent adult readers have not developed the habit of reading. Ways to cultivate adult reading habits include relevant material, environment saturated with reading material, reading aloud to adults, having them read to children, sustained silent reading, modeling, book sharing, author conferences, and recognition. (SK)

  13. Miraculous Readings: Using Fantasy Novels about Reading to Reflect on Reading the Bible

    Science.gov (United States)

    Dalton, Russell W.

    2009-01-01

    This article reflects on the vivid images of reading presented in several popular fantasy novels, including "The Spiderwick Chronicles," "The Great Good Thing," and "The Neverending Story." It suggests that these images can be used to help children, youth, and adults reflect on the nature of reading and the potential power of reading sacred texts.…

  14. Reading Every Single Day: A Journey to Authentic Reading

    Science.gov (United States)

    Hudson, Alida K.; Williams, Joan A.

    2015-01-01

    This article details one teacher's implementation of reading workshop in her second grade classroom. She provided a framework for authentic reading using the five components of reading workshop: time, choice, response, community, and structure. She found that reading workshop is a highly effective practice for not only increasing students'…

  15. Reading Comics

    Science.gov (United States)

    Tilley, Carol L.

    2008-01-01

    Many adults, even librarians who willingly add comics to their collections, often dismiss the importance of comics. Compared to reading "real" books, reading comics appears to be a simple task and compared to reading no books, reading comics might be preferable. After all, comics do have words, but the plentiful pictures seem to carry most of the…

  16. Reading Processes of University Students with Dyslexia - An Examination of the Relationship between Oral Reading and Reading Comprehension.

    Science.gov (United States)

    Pedersen, Henriette Folkmann; Fusaroli, Riccardo; Lauridsen, Lene Louise; Parrila, Rauno

    2016-11-01

    The purpose of this study was to examine the quality of oral reading and how it relates to reading comprehension in students with dyslexia. A group of Danish university students with dyslexia (n = 16) and a comparison group of students with no history of reading problems (n = 16) were assessed on their oral reading performance when reading a complex text. Along with reading speed, we measured not only the number and quality of reading errors but also the extent and semantic nature of the self-corrections during reading. The reading comprehension was measured through aided text retellings. The results showed that, as a group, the dyslexics performed poorer on most measures, but there were notable within-group differences in the reading behaviours and little association between how well university students with dyslexia read aloud and comprehended the text. These findings suggest that many dyslexics in higher education tend to focus their attention on one subcomponent of the reading process, for example, decoding or comprehension, because engaging in both simultaneously may be too demanding for them. Copyright © 2016 John Wiley & Sons, Ltd. Copyright © 2016 John Wiley & Sons, Ltd.

  17. Reading fluency: implications for the assessment of children with reading disabilities.

    Science.gov (United States)

    Meisinger, Elizabeth B; Bloom, Juliana S; Hynd, George W

    2010-06-01

    The current investigation explored the diagnostic utility of reading fluency measures in the identification of children with reading disabilities. Participants were 50 children referred to a university-based clinic because of suspected reading problems and/or a prior diagnosis of dyslexia, where children completed a battery of standardized intellectual, reading achievement, and processing measures. Within this clinical sample, a group of children were identified that exhibited specific deficits in their reading fluency skills with concurrent deficits in rapid naming speed and reading comprehension. This group of children would not have been identified as having a reading disability according to assessment of single word reading skills alone, suggesting that it is essential to assess reading fluency in addition to word reading because failure to do so may result in the under-identification of children with reading disabilities.

  18. "Read the Text, as if!"The Reading Retention Strategy

    Science.gov (United States)

    Divoll, Kent; Browning, Sandra

    2013-01-01

    Students do not always read what is expected in college courses (Berry, Cook, Hill, & Stevens, 2010; Phillips & Phillips, 2007; Sikorski et al., 2002) or they read to cram for an exam or quiz (Clump, Bauer, & Bradley, 2004). The Reading Retention Strategy (RRS) is designed to motivate students to read and assist students in…

  19. Do reading additions improve reading in pre-presbyopes with low vision?

    Science.gov (United States)

    Alabdulkader, Balsam; Leat, Susan

    2012-09-01

    This study compared three different methods of determining a reading addition and the possible improvement on reading performance in children and young adults with low vision. Twenty-eight participants with low vision, aged 8 to 32 years, took part in the study. Reading additions were determined with (a) a modified Nott dynamic retinoscopy, (b) a subjective method, and (c) an age-based formula. Reading performance was assessed with MNREAD-style reading charts at 12.5 cm, with and without each reading addition in random order. Outcome measures were reading speed, critical print size, MNREAD threshold, and the area under the reading speed curve. For the whole group, there was no significant improvement in reading performance with any of the additions. When participants with normal accommodation at 12.5 cm were excluded, the area under the reading speed curve was significantly greater with all reading additions compared with no addition (p = 0.031, 0.028, and 0.028, respectively). Also, the reading acuity threshold was significantly better with all reading additions compared with no addition (p = 0.014, 0.030, and 0.036, respectively). Distance and near visual acuity, age, and contrast sensitivity did not predict improvement with a reading addition. All, but one, of the participants who showed a significant improvement in reading with an addition had reduced accommodation. A reading addition may improve reading performance for young people with low vision and should be considered as part of a low vision assessment, particularly when accommodation is reduced.

  20. Accurate Short-Term Power Forecasting of Wind Turbines: The Case of Jeju Island’s Wind Farm

    OpenAIRE

    BeomJun Park; Jin Hur

    2017-01-01

    Short-term wind power forecasting is a technique which tells system operators how much wind power can be expected at a specific time. Due to the increasing penetration of wind generating resources into the power grids, short-term wind power forecasting is becoming an important issue for grid integration analysis. The high reliability of wind power forecasting can contribute to the successful integration of wind generating resources into the power grids. To guarantee the reliability of forecas...

  1. ConDeTri--a content dependent read trimmer for Illumina data.

    Directory of Open Access Journals (Sweden)

    Linnéa Smeds

    Full Text Available UNLABELLED: During the last few years, DNA and RNA sequencing have started to play an increasingly important role in biological and medical applications, especially due to the greater amount of sequencing data yielded from the new sequencing machines and the enormous decrease in sequencing costs. Particularly, Illumina/Solexa sequencing has had an increasing impact on gathering data from model and non-model organisms. However, accurate and easy to use tools for quality filtering have not yet been established. We present ConDeTri, a method for content dependent read trimming for next generation sequencing data using quality scores of each individual base. The main focus of the method is to remove sequencing errors from reads so that sequencing reads can be standardized. Another aspect of the method is to incorporate read trimming in next-generation sequencing data processing and analysis pipelines. It can process single-end and paired-end sequence data of arbitrary length and it is independent from sequencing coverage and user interaction. ConDeTri is able to trim and remove reads with low quality scores to save computational time and memory usage during de novo assemblies. Low coverage or large genome sequencing projects will especially gain from trimming reads. The method can easily be incorporated into preprocessing and analysis pipelines for Illumina data. AVAILABILITY AND IMPLEMENTATION: Freely available on the web at http://code.google.com/p/condetri.

  2. Metacognitive Online Reading Strategies among Pre-Service EFL Teachers in Indonesia

    Directory of Open Access Journals (Sweden)

    Heri Mudra

    2018-05-01

    Full Text Available The study aimed to establish the metacognitive online reading strategies used by pre-service EFL teachers and to describe their experiences in employing the strategies. This mixed-methods study employed 65 participants (n = 65. The data were collected by using Online Survey of Reading Strategies (OSORS, as developed by Anderson (2003, and through a semi-structured interview. The findings showed that the subscale Global Reading Strategies (GLOB was employed most frequently, followed by Problem Solving Strategies (SOLV and then Support Strategies (SUPP. The most frequent levels of strategies included guessing the contents, scrolling through the texts, associating schemata and current information, using context clues, using tables or pictures, pausing and thinking about the contents, using printed texts, and translating the contents into Indonesian. The interview also reported that the strategies employed were focusing on simplified texts, focusing on colorful texts, translating texts into Indonesian, reading for fun, and utilizing schemata. In short, various strategies can be employed to comprehend and increase better understanding of the online texts.

  3. BLESS 2: accurate, memory-efficient and fast error correction method.

    Science.gov (United States)

    Heo, Yun; Ramachandran, Anand; Hwu, Wen-Mei; Ma, Jian; Chen, Deming

    2016-08-01

    The most important features of error correction tools for sequencing data are accuracy, memory efficiency and fast runtime. The previous version of BLESS was highly memory-efficient and accurate, but it was too slow to handle reads from large genomes. We have developed a new version of BLESS to improve runtime and accuracy while maintaining a small memory usage. The new version, called BLESS 2, has an error correction algorithm that is more accurate than BLESS, and the algorithm has been parallelized using hybrid MPI and OpenMP programming. BLESS 2 was compared with five top-performing tools, and it was found to be the fastest when it was executed on two computing nodes using MPI, with each node containing twelve cores. Also, BLESS 2 showed at least 11% higher gain while retaining the memory efficiency of the previous version for large genomes. Freely available at https://sourceforge.net/projects/bless-ec dchen@illinois.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.

  4. Maternal Reading Self-Efficacy Associated with Perceived Barriers to Reading

    Directory of Open Access Journals (Sweden)

    Joyce Lin

    2015-01-01

    Full Text Available Although early reading practices impact a host of child literacy, language, and school outcomes, many parents do not read to their young children. One possible explanation for this lack of early literacy practices is mothers’ feelings about their ability to successfully read to their children. A series of multiple regressions were used to explore whether new mothers’ reading self-efficacy predicted their perceived barriers to reading to their 18-month-old children. Findings suggest that self-efficacy buffers against mother-centered (e.g., too tired, child-centered (e.g., toddler fussy, and structural (e.g., environmental distractions barriers to reading. Given the importance of early literacy and that not all mothers read to their toddlers, increasing reading self-efficacy may offer a way to reduce perceived barriers to early literacy practices.

  5. Reading Strategies Used by Iranian EFL Learners While Reading Academic Texts

    Directory of Open Access Journals (Sweden)

    Vida Yousefian

    2015-11-01

    Full Text Available The major aim of this study was to explore the nature and frequency of the reading strategies used by the EFL learners while reading academic texts. Normally, students tend to read all the information provided in reading materials. This study explores whether learners use reading strategies to assist them in reading comprehension. There was a sample of 45 English language (EFL learners from Islamic Azad University, Falavarjan Branch. The instrument utilized in this study was a survey questionnaire with 30 items including 13 global reading strategies, 8 problem solving strategies and 9 support reading strategies. The survey was going to signify how much EFL learners use each of these strategies while reading academic texts. The findings indicated that the participants used global reading strategies more (44.5% than problem solving strategies (29.0% and support reading strategies (26.5%. The results of the present study will let the instructors improve the reading strategies which are not used by EFL learners frequently. It also helps learners to promote the ability of using reading strategies and utilize the strategies in an appropriate and effective way.

  6. The Relations between Early Working Memory Abilities and Later Developing Reading Skills: A Longitudinal Study from Kindergarten to Fifth Grade

    Science.gov (United States)

    Nevo, Einat; Bar-Kochva, Irit

    2015-01-01

    This study investigated the relations of early working-memory abilities (phonological and visual-spatial short-term memory [STM] and complex memory and episodic buffer memory) and later developing reading skills. Sixty Hebrew-speaking children were followed from kindergarten through Grade 5. Working memory was tested in kindergarten and reading in…

  7. Davies, Florence (1995. Introducing Reading. Davies, Florence (1995. Introducing Reading.

    Directory of Open Access Journals (Sweden)

    Sonia Maria Gomes Ferreira

    2008-04-01

    Full Text Available Arising at a time of unprecedented growth of interest in fostering critical thinking, Introducing Reading offers a clear introduction and thorough account of contemporary developments in the field of reading. While overtly focusing on the special demands of social and human aspects of the reading practice, the issues raised have crucial resonance in the sphere of critical reading. Explicitly addressed to teachers of mother tongue and foreign language contexts, the book claims to elaborate on aspects of reading which have received meager attention to date: individual readers engaged in different real-world reading tasks, the social contexts where such readers engage and interact with texts, and the nature and variety of texts, here regarded as “participants” in the interaction between reader and writer. To this extent, the book successfully reaches the ambitious aim of “socializing and humanizing reading and the teaching of reading” (p. xi. Arising at a time of unprecedented growth of interest in fostering critical thinking, Introducing Reading offers a clear introduction and thorough account of contemporary developments in the field of reading. While overtly focusing on the special demands of social and human aspects of the reading practice, the issues raised have crucial resonance in the sphere of critical reading. Explicitly addressed to teachers of mother tongue and foreign language contexts, the book claims to elaborate on aspects of reading which have received meager attention to date: individual readers engaged in different real-world reading tasks, the social contexts where such readers engage and interact with texts, and the nature and variety of texts, here regarded as “participants” in the interaction between reader and writer. To this extent, the book successfully reaches the ambitious aim of “socializing and humanizing reading and the teaching of reading” (p. xi.

  8. The Relation of Age and Reading Ability to Memory Processing.

    Science.gov (United States)

    Marrach, Alexa; Fireman, Gary

    This study examined the relation of reading ability, age, and familiarity to iconic and short-term memory processing and how the familiarity of the stimuli affects recall. A total of 10 children in grades 2 through 6 and 10 adults were shown novel abstract forms, words, and non-words varying in order of approximation to English, for 50 msec., 500…

  9. Book Clubs in Developmental Reading: Building Reading Comprehension, Fostering Reading Enjoyment, and Engaging Students

    Science.gov (United States)

    Maldonado, Michele

    2012-01-01

    The use of book clubs in college developmental reading classes is an effective way to encourage reluctant readers to build and strengthen reading skills, foster reading enjoyment, and engage students. In addition, book clubs build a sense of community within the classroom as the students converse and share their interpretations of the reading…

  10. Encouraging Reading through an Enactive Method: Strategies for Hearing Impaired Children.

    Science.gov (United States)

    Winzer, M. A.

    The paper describes the enactive method, an alternative approach to introducing and teaching reading to young hearing impaired children. The method actively involves the child as a processor of the material rather than as a passive consumer. The approach is established for a short period of time each day until the student outgrows its original…

  11. Motivational reading on education, meaningful reading realisation

    Directory of Open Access Journals (Sweden)

    Adriana Qafa

    2017-07-01

    Full Text Available In this study I will present some ideas on today’s educational practice for motivation, the realization of the meaningful reading. There is a special place for the methodical ranking of the reading process, starting in school. Main requests of this reading, consist of the deep meaning of the subject, exploration of the idea, and other elements of the subject, implementation of the technique’s rules of the expressive reading, such as breathing, voice, diction, intonation, spelling, stoppages, logical emphasizes, emotional expressions, temper, timber, gesticulations, and mimic. There is also highlighted the fact that the used method comes from the pupils’ results and depends on the capability and level of the teacher, from the programming’s scale, the tools that are put into disposition, the age and the level of the pupils, and from the environment that the teacher creates during courses. At the end there are some practical guidelines for the realization of the expressive reading in the literature subject.

  12. Word Reading Efficiency, Text Reading Fluency, and Reading Comprehension among Chinese Learners of English

    Science.gov (United States)

    Jiang, Xiangying; Sawaki, Yasuyo; Sabatini, John

    2012-01-01

    This study examined the relationship among word reading efficiency, text reading fluency, and reading comprehension for adult English as a Foreign Language (EFL) learners. Data from 185 adult Chinese EFL learners preparing to take the Test-of-English-as-a-Foreign-Language[TM] (TOEFL[R]) were analyzed in this study. The participants completed a…

  13. Short-time quantum propagator and Bohmian trajectories

    Science.gov (United States)

    de Gosson, Maurice; Hiley, Basil

    2013-12-01

    We begin by giving correct expressions for the short-time action following the work Makri-Miller. We use these estimates to derive an accurate expression modulo Δt2 for the quantum propagator and we show that the quantum potential is negligible modulo Δt2 for a point source, thus justifying an unfortunately largely ignored observation of Holland made twenty years ago. We finally prove that this implies that the quantum motion is classical for very short times.

  14. Short-time quantum propagator and Bohmian trajectories

    International Nuclear Information System (INIS)

    Gosson, Maurice de; Hiley, Basil

    2013-01-01

    We begin by giving correct expressions for the short-time action following the work Makri–Miller. We use these estimates to derive an accurate expression modulo Δt 2 for the quantum propagator and we show that the quantum potential is negligible modulo Δt 2 for a point source, thus justifying an unfortunately largely ignored observation of Holland made twenty years ago. We finally prove that this implies that the quantum motion is classical for very short times.

  15. WGSQuikr: fast whole-genome shotgun metagenomic classification.

    Directory of Open Access Journals (Sweden)

    David Koslicki

    Full Text Available With the decrease in cost and increase in output of whole-genome shotgun technologies, many metagenomic studies are utilizing this approach in lieu of the more traditional 16S rRNA amplicon technique. Due to the large number of relatively short reads output from whole-genome shotgun technologies, there is a need for fast and accurate short-read OTU classifiers. While there are relatively fast and accurate algorithms available, such as MetaPhlAn, MetaPhyler, PhyloPythiaS, and PhymmBL, these algorithms still classify samples in a read-by-read fashion and so execution times can range from hours to days on large datasets. We introduce WGSQuikr, a reconstruction method which can compute a vector of taxonomic assignments and their proportions in the sample with remarkable speed and accuracy. We demonstrate on simulated data that WGSQuikr is typically more accurate and up to an order of magnitude faster than the aforementioned classification algorithms. We also verify the utility of WGSQuikr on real biological data in the form of a mock community. WGSQuikr is a Whole-Genome Shotgun QUadratic, Iterative, K-mer based Reconstruction method which extends the previously introduced 16S rRNA-based algorithm Quikr. A MATLAB implementation of WGSQuikr is available at: http://sourceforge.net/projects/wgsquikr.

  16. Short-term memory predictions across the lifespan: monitoring span before and after conducting a task.

    Science.gov (United States)

    Bertrand, Julie Marilyne; Moulin, Chris John Anthony; Souchay, Céline

    2017-05-01

    Our objective was to explore metamemory in short-term memory across the lifespan. Five age groups participated in this study: 3 groups of children (4-13 years old), and younger and older adults. We used a three-phase task: prediction-span-postdiction. For prediction and postdiction phases, participants reported with a Yes/No response if they could recall in order a series of images. For the span task, they had to actually recall such series. From 4 years old, children have some ability to monitor their short-term memory and are able to adjust their prediction after experiencing the task. However, accuracy still improves significantly until adolescence. Although the older adults had a lower span, they were as accurate as young adults in their evaluation, suggesting that metamemory is unimpaired for short-term memory tasks in older adults. •We investigate metamemory for short-term memory tasks across the lifespan. •We find younger children cannot accurately predict their span length. •Older adults are accurate in predicting their span length. •People's metamemory accuracy was related to their short-term memory span.

  17. Developing New Reading Assessments to Promote Beginning Reading in Singapore

    Science.gov (United States)

    Koh, Kim H.; Paris, Scott G.

    2011-01-01

    Effective reading instruction and intervention are rooted in effective assessments of children's developing skills in reading. The article aims to describe the development of new reading assessments to help promote beginning reading in Singapore primary schools. We begin with an introduction to the educational landscape and policies before…

  18. READSCAN: A fast and scalable pathogen discovery program with accurate genome relative abundance estimation

    KAUST Repository

    Naeem, Raeece

    2012-11-28

    Summary: READSCAN is a highly scalable parallel program to identify non-host sequences (of potential pathogen origin) and estimate their genome relative abundance in high-throughput sequence datasets. READSCAN accurately classified human and viral sequences on a 20.1 million reads simulated dataset in <27 min using a small Beowulf compute cluster with 16 nodes (Supplementary Material). Availability: http://cbrc.kaust.edu.sa/readscan Contact: or raeece.naeem@gmail.com Supplementary information: Supplementary data are available at Bioinformatics online. 2012 The Author(s).

  19. READSCAN: A fast and scalable pathogen discovery program with accurate genome relative abundance estimation

    KAUST Repository

    Naeem, Raeece; Rashid, Mamoon; Pain, Arnab

    2012-01-01

    Summary: READSCAN is a highly scalable parallel program to identify non-host sequences (of potential pathogen origin) and estimate their genome relative abundance in high-throughput sequence datasets. READSCAN accurately classified human and viral sequences on a 20.1 million reads simulated dataset in <27 min using a small Beowulf compute cluster with 16 nodes (Supplementary Material). Availability: http://cbrc.kaust.edu.sa/readscan Contact: or raeece.naeem@gmail.com Supplementary information: Supplementary data are available at Bioinformatics online. 2012 The Author(s).

  20. Reading Speed as a Constraint of Accuracy of Self-Perception of Reading Skill

    Science.gov (United States)

    Kwon, Heekyung; Linderholm, Tracy

    2015-01-01

    We hypothesised that college students take reading speed into consideration when evaluating their own reading skill, even if reading speed does not reliably predict actual reading skill. To test this hypothesis, we measured self-perception of reading skill, self-perception of reading speed, actual reading skill and actual reading speed to…

  1. Exploring Students' Reading Profiles to Guide a Reading Intervention Programme

    Science.gov (United States)

    Boakye, Naomi A. N. Y.

    2017-01-01

    There have been a number of studies on reading interventions to improve students' reading proficiency, yet the majority of these interventions are undertaken with the assumption that students' reading challenges are obvious and generic in nature. The interventions do not take into consideration the diversity in students' reading backgrounds and…

  2. Accurate Medium-Term Wind Power Forecasting in a Censored Classification Framework

    DEFF Research Database (Denmark)

    Dahl, Christian M.; Croonenbroeck, Carsten

    2014-01-01

    We provide a wind power forecasting methodology that exploits many of the actual data's statistical features, in particular both-sided censoring. While other tools ignore many of the important “stylized facts” or provide forecasts for short-term horizons only, our approach focuses on medium......-term forecasts, which are especially necessary for practitioners in the forward electricity markets of many power trading places; for example, NASDAQ OMX Commodities (formerly Nord Pool OMX Commodities) in northern Europe. We show that our model produces turbine-specific forecasts that are significantly more...... accurate in comparison to established benchmark models and present an application that illustrates the financial impact of more accurate forecasts obtained using our methodology....

  3. Quantum-Accurate Molecular Dynamics Potential for Tungsten

    Energy Technology Data Exchange (ETDEWEB)

    Wood, Mitchell; Thompson, Aidan P.

    2017-03-01

    The purpose of this short contribution is to report on the development of a Spectral Neighbor Analysis Potential (SNAP) for tungsten. We have focused on the characterization of elastic and defect properties of the pure material in order to support molecular dynamics simulations of plasma-facing materials in fusion reactors. A parallel genetic algorithm approach was used to efficiently search for fitting parameters optimized against a large number of objective functions. In addition, we have shown that this many-body tungsten potential can be used in conjunction with a simple helium pair potential1 to produce accurate defect formation energies for the W-He binary system.

  4. Quantifying Short-Chain Chlorinated Paraffin Congener Groups

    NARCIS (Netherlands)

    Yuan, Bo; Bogdal, Christian; Berger, Urs; MacLeod, Matthew; Gebbink, Wouter A.; Alsberg, Tomas; Wit, de Cynthia A.

    2017-01-01

    Accurate quantification of short-chain chlorinated paraffins (SCCPs) poses an exceptional challenge to analytical chemists. SCCPs are complex mixtures of chlorinated alkanes with variable chain length and chlorination level; congeners with a fixed chain length (n) and number of chlorines (m) are

  5. Connected text reading and differences in text reading fluency in adult readers.

    Directory of Open Access Journals (Sweden)

    Sebastian Wallot

    Full Text Available The process of connected text reading has received very little attention in contemporary cognitive psychology. This lack of attention is in parts due to a research tradition that emphasizes the role of basic lexical constituents, which can be studied in isolated words or sentences. However, this lack of attention is in parts also due to the lack of statistical analysis techniques, which accommodate interdependent time series. In this study, we investigate text reading performance with traditional and nonlinear analysis techniques and show how outcomes from multiple analyses can used to create a more detailed picture of the process of text reading. Specifically, we investigate reading performance of groups of literate adult readers that differ in reading fluency during a self-paced text reading task. Our results indicate that classical metrics of reading (such as word frequency do not capture text reading very well, and that classical measures of reading fluency (such as average reading time distinguish relatively poorly between participant groups. Nonlinear analyses of distribution tails and reading time fluctuations provide more fine-grained information about the reading process and reading fluency.

  6. The role of speech prosody and text reading prosody in children's reading comprehension.

    Science.gov (United States)

    Veenendaal, Nathalie J; Groen, Margriet A; Verhoeven, Ludo

    2014-12-01

    Text reading prosody has been associated with reading comprehension. However, text reading prosody is a reading-dependent measure that relies heavily on decoding skills. Investigation of the contribution of speech prosody - which is independent from reading skills - in addition to text reading prosody, to reading comprehension could provide more insight into the general role of prosody in reading comprehension. The current study investigates how much variance in reading comprehension scores is explained by speech prosody and text reading prosody, after controlling for decoding, vocabulary, and syntactic awareness. A battery of reading and language assessments was performed by 106 Dutch fourth-grade primary school children. Speech prosody was assessed using a storytelling task and text reading prosody by oral text reading performance. Decoding skills, vocabulary, syntactic awareness, and reading comprehension were assessed using standardized tests. Hierarchical regression analyses showed that text reading prosody explained 6% of variance and that speech prosody explained 8% of variance in reading comprehension scores, after controlling for decoding, vocabulary, and syntactic awareness. Phrasing was the significant factor in both speech and text reading. When added in consecutive order, phrasing in speech added 5% variance to phrasing in reading. In contrast, phrasing in reading added only 3% variance to phrasing in speech. The variance that speech prosody explained in reading comprehension scores should not be neglected. Speech prosody seems to facilitate the construction of meaning in written language. © 2014 The British Psychological Society.

  7. Short-time quantum propagator and Bohmian trajectories

    Energy Technology Data Exchange (ETDEWEB)

    Gosson, Maurice de, E-mail: maurice.degosson@gmail.com [Universität Wien, Fakultät für Mathematik, NuHAG, Wien 1090 (Austria); Hiley, Basil [University of London, Birkbeck College, Theoretical Physics Unit, London WC1E 7HX (United Kingdom)

    2013-12-06

    We begin by giving correct expressions for the short-time action following the work Makri–Miller. We use these estimates to derive an accurate expression modulo Δt{sup 2} for the quantum propagator and we show that the quantum potential is negligible modulo Δt{sup 2} for a point source, thus justifying an unfortunately largely ignored observation of Holland made twenty years ago. We finally prove that this implies that the quantum motion is classical for very short times.

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

  9. Idea Sharing: The Use of Read-Share-Act to Promote Extensive Reading

    Science.gov (United States)

    Charumanee, Nisakorn

    2014-01-01

    Nisakorn Charumanee believes that a reading teacher has an active role in cultivating reading culture or reading habit and in activating students to "want" to read. One way to do this is to integrate extensive reading into the classroom (Day and Bamford, 1998; Bamford and Day, 2004) where extensive reading can be enhanced if the teacher…

  10. The Effects of Reading Recovery on Children's Literacy Progress and Special Educational Needs Status: A Three-Year Follow-Up Study

    Science.gov (United States)

    Holliman, Andrew J.; Hurry, Jane

    2013-01-01

    Reading Recovery (RR) is an intensive one-to-one reading intervention programme designed for five- to six-year-old children who are the lowest literacy achievers after one year of formal tuition. RR has been shown to have impressive effects in the short-term, particularly on those measures tailored to, and designed for, the programme. However,…

  11. Order short-term memory is not specifically impaired in dyslexia and does not affect orthographic learning

    Directory of Open Access Journals (Sweden)

    Eva eStaels

    2014-09-01

    Full Text Available This article reports two studies that investigate short-term memory (STM deficits in dyslexic children and explores the relationship between short-term memory and reading acquisition. In the first experiment, thirty-six dyslexic children and sixty-one control children performed an item STM task and a serial order STM task. The results of this experiment show that dyslexic children do not suffer from a specific serial order STM deficit. In addition, the results demonstrate that phonological processing skills are as closely related to both item STM and serial order STM. However, nonverbal intelligence was more strongly involved in serial order STM than in item STM. In the second experiment, the same two STM tasks were administered and reading acquisition was assessed by measuring orthographic learning in a group of one hundred and eighty-eight children. The results of this study show that orthographic learning is exclusively related to item STM and not to order STM. It is concluded that serial order STM is not the right place to look for a causal explanation of reading disability, nor for differences in word reading acquisition.

  12. The Assessment of Reading Comprehension Difficulties for Reading Intervention

    Science.gov (United States)

    Woolley, Gary

    2008-01-01

    There are many environmental and personal factors that contribute to reading success. Reading comprehension is a complex interaction of language, sensory perception, memory, and motivational aspects. However, most existing assessment tools have not adequately reflected the complex nature of reading comprehension. Good assessment requires a…

  13. The Role of Speech Prosody and Text Reading Prosody in Children's Reading Comprehension

    Science.gov (United States)

    Veenendaal, Nathalie J.; Groen, Margriet A.; Verhoeven, Ludo

    2014-01-01

    Background: Text reading prosody has been associated with reading comprehension. However, text reading prosody is a reading-dependent measure that relies heavily on decoding skills. Investigation of the contribution of speech prosody--which is independent from reading skills--in addition to text reading prosody, to reading comprehension could…

  14. Survey Guidelines and its Reading Criteria for Monitoring and Transmitting Cultural Heritage Values

    Science.gov (United States)

    De Masi, A.

    2015-08-01

    The paper describes reading criteria for an analysis and interpretation of material systems in relation to a built space, survey guidelines and its reading criteria for Cultural Heritage (CH) values'monitoring and transmission. In addition, integrated systems of digital technologies and 2D/3D digitization of CH are introduced for an effective and accurate reading of Venice and Milan's monuments. Specifically, the guidelines for an architectural survey allow to organize and document historic monuments information, and to identify the significant cultural/physical elements of our past in order for them to be preserved and protected for future generations. In addition, in this paper the studied projects introduce a combination of virtual technologies and historical reality with experimenting innovative solutions for CH. From the methodological point of view, this study has made use of the identification of levels of study (LS) differentiated, each of which is capable of identifying categories.

  15. To read or not to read

    NARCIS (Netherlands)

    Mol, Suzanne Elizabeth

    2010-01-01

    There is a widely held belief that reading (story)books makes us smarter and helps promote success in life. Does scientific evidence support this notion? The three meta-analyses in this thesis comprise 146 studies between 1988 and 2010 (N=10,308 participants) that addressed the role of book reading

  16. Teachers’ beliefs about reading and use of reading strategies

    OpenAIRE

    VASILIKA RRAKU

    2014-01-01

    The aim of this article is to place the focus on teachers’ beliefs about reading and reading strategies to the purpose of emphasizing the im portance of reading strategies in the reading process. The method of study is analytic analysis of teachers’ beliefs obtained through ques tionnaires delivered to 18 English language teachers of elementary, secondary and high level education in the region of Saranda in lbania. The results of the study pointed to a great concordance between teach ers’ bel...

  17. Connecting Reading and Writing Using Children's Literature in the University L2 Classroom

    Science.gov (United States)

    Leal, Priscila

    2015-01-01

    This article investigates the potential benefits of using children's literature in adult second language (L2) classrooms. A short-term, intensive university course for English reading and writing was designed incorporating children's literature into the curriculum. The author describes the course and discusses how children's literature can be used…

  18. Critical Reading Skills and Translation Ability of Thai EFL Students: Pragmatic, Syntactic, and Semantic Aspects

    Science.gov (United States)

    Sriwantaneeyakul, Suttawan

    2018-01-01

    Translation ability requires many language skills to produce an accurate and complete text; however, one important skill, critical reading in the research, has been neglected. This research, therefore, employed the explanatory sequential mixed method to investigate the differences in Thai-English translation ability between students with a high…

  19. Intact Acquisition and Short-Term Retention of Non-Motor Procedural Learning in Parkinson's Disease.

    Directory of Open Access Journals (Sweden)

    Muriel T N Panouillères

    Full Text Available Procedural learning is a form of memory where people implicitly acquire a skill through repeated practice. People with Parkinson's disease (PD have been found to acquire motor adaptation, a form of motor procedural learning, similarly to healthy older adults but they have deficits in long-term retention. A similar pattern of normal learning on initial exposure with a deficit in retention seen on subsequent days has also been seen in mirror-reading, a form of non-motor procedural learning. It is a well-studied fact that disrupting sleep will impair the consolidation of procedural memories. Given the prevalence of sleep disturbances in PD, the lack of retention on following days seen in these studies could simply be a side effect of this well-known symptom of PD. Because of this, we wondered whether people with PD would present with deficits in the short-term retention of a non-motor procedural learning task, when the test of retention was done the same day as the initial exposure. The aim of the present study was then to investigate acquisition and retention in the immediate short term of cognitive procedural learning using the mirror-reading task in people with PD. This task involved two conditions: one where triads of mirror-inverted words were always new that allowed assessing the learning of mirror-reading skill and another one where some of the triads were presented repeatedly during the experiment that allowed assessing the word-specific learning. People with PD both ON and OFF their normal medication were compared to healthy older adults and young adults. Participants were re-tested 50 minutes break after initial exposure to probe for short-term retention. The results of this study show that all groups of participants acquired and retained the two skills (mirror-reading and word-specific similarly. These results suggest that neither healthy ageing nor the degeneration within the basal ganglia that occurs in PD does affect the mechanisms

  20. Multicultural Reading

    Science.gov (United States)

    Veltze, Linda

    2004-01-01

    Multicultural reading advocates believe in the power of literature to transform and to change people's lives. They take seriously the arguments that racism and prejudice can be lessened through multicultural reading, and also that children from undervalued societal groups who read books that depict people like themselves in a positive light will…

  1. Early phonological skills as a predictor of reading acquisition: a follow-up study from kindergarten to the middle of grade 2.

    Science.gov (United States)

    Sprugevica, Ieva; Høien, Torleiv

    2003-04-01

    The purpose of this study was to investigate the power of early measures of phonological skills (phonemic awareness, rapid naming, short-term memory) in predicting later reading skills at various points of time. About 70 children were followed from the end of kindergarten to the middle of grade 2. Correlation analyses were performed as well as a linear growth curve analyses. In the traditional regression analysis, phonemic awareness in kindergarten explained about 27% of the variance in word reading six months later and about 9.5% of the variance at the end of grade 1. Even when prior level of reading skill was included in the predictive equation, a significant amount of variance was still explained by phonemic awareness. The other predictor variables did not explain any variance in word reading, and phonemic awareness did not predict any variance in reading skills in grade 2. When using sentence reading as the dependent variable, phonemic awareness explained about 16% of unique variance after six months, and about 13% of the variance in the middle of grade 2. Similarly, when employing growth curve analysis, phonemic awareness was the only phonological factor that accounted for significant variance in the word reading slope, explaining about 25% of its variance, whereas naming and short-term memory did not explain any unique variance. The lack of predictive power of phonemic awareness on the sentence b-slope is assumed to be caused by unreliable sentence scores in kindergarten.

  2. Phonological Working Memory in German Children with Poor Reading and Spelling Abilities

    Science.gov (United States)

    Steinbrink, Claudia; Klatte, Maria

    2008-01-01

    Deficits in verbal short-term memory have been identified as one factor underlying reading and spelling disorders. However, the nature of this deficit is still unclear. It has been proposed that poor readers make less use of phonological coding, especially if the task can be solved through visual strategies. In the framework of Baddeley's…

  3. Accurate shear measurement with faint sources

    International Nuclear Information System (INIS)

    Zhang, Jun; Foucaud, Sebastien; Luo, Wentao

    2015-01-01

    For cosmic shear to become an accurate cosmological probe, systematic errors in the shear measurement method must be unambiguously identified and corrected for. Previous work of this series has demonstrated that cosmic shears can be measured accurately in Fourier space in the presence of background noise and finite pixel size, without assumptions on the morphologies of galaxy and PSF. The remaining major source of error is source Poisson noise, due to the finiteness of source photon number. This problem is particularly important for faint galaxies in space-based weak lensing measurements, and for ground-based images of short exposure times. In this work, we propose a simple and rigorous way of removing the shear bias from the source Poisson noise. Our noise treatment can be generalized for images made of multiple exposures through MultiDrizzle. This is demonstrated with the SDSS and COSMOS/ACS data. With a large ensemble of mock galaxy images of unrestricted morphologies, we show that our shear measurement method can achieve sub-percent level accuracy even for images of signal-to-noise ratio less than 5 in general, making it the most promising technique for cosmic shear measurement in the ongoing and upcoming large scale galaxy surveys

  4. Individual Differences in Sensitivity to Style During Literary Reading: Insights from Eye-Tracking

    Directory of Open Access Journals (Sweden)

    Emiel van den Hoven

    2016-12-01

    Full Text Available Style is an important aspect of literature, and stylistic deviations are sometimes labeled foregrounded, since their manner of expression deviates from the stylistic default. Russian Formalists have claimed that foregrounding increases processing demands and therefore causes slower reading – an effect called retardation. We tested this claim experimentally by having participants read short literary stories while measuring their eye movements. Our results confirm that readers indeed read slower and make more regressions towards foregrounded passages as compared to passages that are not foregrounded. A closer look, however, reveals significant individual differences in sensitivity to foregrounding. Some readers in fact do not slow down at all when reading foregrounded passages. The slowing down effect for literariness was related to a slowing down effect for high perplexity (unexpected words: those readers who slowed down more during literary passages also slowed down more during high perplexity words, even though no correlation between literariness and perplexity existed in the stories. We conclude that individual differences play a major role in processing of literary texts and argue for accounts of literary reading that focus on the interplay between reader and text.

  5. SchemaOnRead: A Package for Schema-on-Read in R

    Energy Technology Data Exchange (ETDEWEB)

    North, Michael J.

    2016-08-01

    Schema-on-read is an agile approach to data storage and retrieval that defers investments in data organization until production queries need to be run by working with data directly in native form. Schema-on-read functions have been implemented in a wide range of analytical systems, most notably Hadoop. SchemaOnRead is a CRAN package that uses R’s flexible data representations to provide transparent and convenient support for the schema-on-read paradigm in R. The schema-on- read tools within the package include a single function call that recursively reads folders with text, comma separated value, raster image, R data, HDF5, NetCDF, spreadsheet, Weka, Epi Info, Pajek network, R network, HTML, SPSS, Systat, and Stata files. The provided tools can be used as-is or easily adapted to implement customized schema-on-read tool chains in R. This paper’s contribution is that it introduces and describes SchemaOnRead, the first R package specifically focused on providing explicit schema-on-read support in R.

  6. Examining Associations between Reading Motivation and Inference Generation beyond Reading Comprehension Skill

    Science.gov (United States)

    Clinton, Virginia

    2015-01-01

    The purpose of this study was to examine the associations between reading motivation and inference generation while reading. Undergraduate participants (N = 69) read two science articles while thinking aloud, completed a standardized reading comprehension assessment, and self reported their habitual reading motivation. Findings indicate that…

  7. Reading Amount as a Mediator of the Effects of Intrinsic and Extrinsic Reading Motivation on Reading Comprehension

    Science.gov (United States)

    Schaffner, Ellen; Schiefele, Ulrich; Ulferts, Hannah

    2013-01-01

    This study examined the role of reading amount as a mediator of the effects of intrinsic and extrinsic reading motivation on higher order reading comprehension (comprised of paragraph-and passage-level comprehension) in a sample of 159 fifth-grade elementary students. A positive association between intrinsic reading motivation and reading amount…

  8. The relationship between different measures of oral reading fluency and reading comprehension in second-grade students who evidence different oral reading fluency difficulties.

    Science.gov (United States)

    Wise, Justin C; Sevcik, Rose A; Morris, Robin D; Lovett, Maureen W; Wolf, Maryanne; Kuhn, Melanie; Meisinger, Beth; Schwanenflugel, Paula

    2010-07-01

    The purpose of this study was to examine whether different measures of oral reading fluency relate differentially to reading comprehension performance in two samples of second-grade students: (a) students who evidenced difficulties with nonsense-word oral reading fluency, real-word oral reading fluency, and oral reading fluency of connected text (ORFD), and (b) students who evidenced difficulties only with oral reading fluency of connected text (CTD). Participants (ORFD, n = 146 and CTD, n = 949) were second-grade students who were recruited for participation in different reading intervention studies. Data analyzed were from measures of nonsense-word oral reading fluency, real-word oral reading fluency, oral reading fluency of connected text, and reading comprehension that were collected at the pre-intervention time point. Correlational and path analyses indicated that real-word oral reading fluency was the strongest predictor of reading comprehension performance in both samples and across average and poor reading comprehension abilities. Results of this study indicate that real-word oral reading fluency was the strongest predictor of reading comprehension and suggest that real-word oral reading fluency may be an efficient method for identifying potential reading comprehension difficulties.

  9. Reading motivation, reading amount, and text comprehension in deaf and hearing adults.

    Science.gov (United States)

    Parault, Susan J; Williams, Heather M

    2010-01-01

    The purpose of this study is to examine the relationship between the variables of reading motivation, reading amount, and text comprehension in deaf and hearing adults. Research has shown that less than 50% of deaf students leave high school reading at or above a fourth-grade level (Allen, 1994). Our question is, how does this affect the levels of reading motivation and amount of reading in which deaf adults engage? Assessments of 30 hearing and 24 deaf adults showed that deaf participants reported significantly higher levels of reading motivation despite having been found to read at less than a sixth-grade level. No significant difference in the amount of reading between hearing and deaf adults was found. Amount of reading for personal reasons was found to be the best predictor of text comprehension in the deaf participants, and intrinsic motivation was found to be the best predictor of amount of reading in the deaf participants.

  10. Cognitive Abilities Underlying Reading Accuracy, Fluency and Spelling Acquisition in Korean Hangul Learners from Grades 1 to 4: A Cross-Sectional Study.

    Science.gov (United States)

    Park, Hyun-Rin; Uno, Akira

    2015-08-01

    The purpose of this cross-sectional study was to examine the cognitive abilities that predict reading and spelling performance in Korean children in Grades 1 to 4, depending on expertise and reading experience. As a result, visual cognition, phonological awareness, naming speed and receptive vocabulary significantly predicted reading accuracy in children in Grades 1 and 2, whereas visual cognition, phonological awareness and rapid naming speed did not predict reading accuracy in children in higher grades. For reading, fluency, phonological awareness, rapid naming speed and receptive vocabulary were crucial abilities in children in Grades 1 to 3, whereas phonological awareness was not a significant predictor in children in Grade 4. In spelling, reading ability and receptive vocabulary were the most important abilities for accurate Hangul spelling. The results suggested that the degree of cognitive abilities required for reading and spelling changed depending on expertise and reading experience. Copyright © 2015 John Wiley & Sons, Ltd.

  11. An investigation of Chinese university EFL learner’s foreign language reading anxiety, reading strategy use and reading comprehension performance

    OpenAIRE

    Zhongshe Lu; Meihua Liu

    2015-01-01

    The present study explored the interrelations between foreign language (FL) reading anxiety, FL reading strategy use and their interactive effect on FL reading comprehension performance at the tertiary level in China. Analyses of the survey data collected from 1702 university students yielded the following results: (a) Both Foreign Language Reading Anxiety Scale (FLRAS) and Foreign Language Reading Strategy Use Scale (FLRSUS) had important subcomponents, (b) more than half of the stu...

  12. The Language Desert: The Condition of Literacy and Reading in Contemporary America

    Directory of Open Access Journals (Sweden)

    Michael Tracey

    2015-01-01

    Full Text Available This essay is an engagement with a series of propositions about literacy and reading in the United States: that large numbers of people struggle with what one might call narrative complexity; that they resolve such struggles by falling back onto narrative simplicities which, through a series of cultural preferences, congeal to produce much of the stuff of popular culture; that this condition and process is essentially what the varied critics—from left and right—of the culture of modernity were actually identifying, though from a largely normative, not empirical, standpoint; that what was being critiqued was essentially a condition formed by cognitive underdevelopment; and that we can actually explain this empirically by mining decades’ worth of research in reading and literacy studies, particularly in the context of childhood and social class. In short, this paper is an admittedly tentative step in an effort to build a bridge between two knowledge silos that have in part remained determinably apart—reading/literacy studies and cultural/critical theory. The essay also suggests that, in order to understand reading and literacy, it is important to begin to engage research in neuroscience, particularly that which suggests that the brain is actually not designed—in evolutionary terms—to read.

  13. Neural Signatures of the Reading-Writing Connection: Greater Involvement of Writing in Chinese Reading than English Reading.

    Science.gov (United States)

    Cao, Fan; Perfetti, Charles A

    2016-01-01

    Research on cross-linguistic comparisons of the neural correlates of reading has consistently found that the left middle frontal gyrus (MFG) is more involved in Chinese than in English. However, there is a lack of consensus on the interpretation of the language difference. Because this region has been found to be involved in writing, we hypothesize that reading Chinese characters involves this writing region to a greater degree because Chinese speakers learn to read by repeatedly writing the characters. To test this hypothesis, we recruited English L1 learners of Chinese, who performed a reading task and a writing task in each language. The English L1 sample had learned some Chinese characters through character-writing and others through phonological learning, allowing a test of writing-on-reading effect. We found that the left MFG was more activated in Chinese than English regardless of task, and more activated in writing than in reading regardless of language. Furthermore, we found that this region was more activated for reading Chinese characters learned by character-writing than those learned by phonological learning. A major conclusion is that writing regions are also activated in reading, and that this reading-writing connection is modulated by the learning experience. We replicated the main findings in a group of native Chinese speakers, which excluded the possibility that the language differences observed in the English L1 participants were due to different language proficiency level.

  14. Neural Signatures of the Reading-Writing Connection: Greater Involvement of Writing in Chinese Reading than English Reading.

    Directory of Open Access Journals (Sweden)

    Fan Cao

    Full Text Available Research on cross-linguistic comparisons of the neural correlates of reading has consistently found that the left middle frontal gyrus (MFG is more involved in Chinese than in English. However, there is a lack of consensus on the interpretation of the language difference. Because this region has been found to be involved in writing, we hypothesize that reading Chinese characters involves this writing region to a greater degree because Chinese speakers learn to read by repeatedly writing the characters. To test this hypothesis, we recruited English L1 learners of Chinese, who performed a reading task and a writing task in each language. The English L1 sample had learned some Chinese characters through character-writing and others through phonological learning, allowing a test of writing-on-reading effect. We found that the left MFG was more activated in Chinese than English regardless of task, and more activated in writing than in reading regardless of language. Furthermore, we found that this region was more activated for reading Chinese characters learned by character-writing than those learned by phonological learning. A major conclusion is that writing regions are also activated in reading, and that this reading-writing connection is modulated by the learning experience. We replicated the main findings in a group of native Chinese speakers, which excluded the possibility that the language differences observed in the English L1 participants were due to different language proficiency level.

  15. Reading Approach Use Effectiveness And EFL Reading Comprehension In University Muhammadiyah Of Parepare

    Directory of Open Access Journals (Sweden)

    Baharuddin

    2017-10-01

    Full Text Available This study investigated Indonesian EFL learners approach of two reading approaches cognitive and metacognitive their perceived contact on effectiveness and the association between reading approach and effectiveness on their English reading comprehension. Fifty-Three English-major freshmen from University Muhammadiyah of Parepare participated in these lessons. Two principal questions were addressed 1 what is the most frequent use of reading approach reported by individual students 2 Is there any significant association between reading approach and effectiveness on their English reading comprehension To examine the effects of approach instruction on students reading performance a qualitative interview technique and quantitative research methods including a paired-sample t-test and Person Product Moment Correlation were used to estimate the relationship between reading approach use and effectiveness on students reading accomplishment. Significance showed that the most frequent use of reading approach was found to be metacognitive approach followed by the cognitive approach. In addition there was a significant positive connection between reading approach and effectiveness on their English reading comprehension. Reading approach on the other hand was unrelated to reading achievement. Results of interview findings were analyzed to explore in-depth in sequence about the condition of approach used. The implications of these findings for implementing effective reading strategy instruction are discussed.

  16. Pupil's motivation in the 3. grades for required reading and The Reading Badge

    OpenAIRE

    Logar, Renata

    2013-01-01

    Reading is extremely important for pupils and their development. The pupil with reading habits riches his vocabulary and gaining knowledge. On the other hand the pupil through reading entry into the world of imagination and stories. Major role in motivating students to read have parents and teachers. In this graduation thesis I was interested in how third grade teachers motivate their pupils to read. In doing so, I was focused mainly to reading for required reading and The Reading Badge. ...

  17. COLLABORATIVE STRATEGIC READING IMPLEMENTATION TO IMPROVE STUDENTS’ READING COMPREHENSION

    Directory of Open Access Journals (Sweden)

    Desy Olivia Riani

    2013-01-01

    Full Text Available This collaborative action research is aimed to find out whether or not the implementation of Collaborative Strategic Reading (CSR improves students' reading comprehension and also to identify students' attitude towards the implementation of CSR. CSR is reading strategy that employs four strategies namely Preview, Click and Clunk, Get the Gist and Wrap Up during students’ cooperative learning. A class of eleventh grade students of a public senior high school in Majalengka, West Java, Indonesia is participated as the participant of the study. The required data were collected through the use of questionnaire, observation checklist, and reading test. The data from the questionnaire indicated that 82% students had positive attitude toward the implementation of CSR. They feel that CSR improves their motivation in learning English and CSR brings more fun to the process of learning. Moreover, it was found from observation data that the students were actively participated during CSR implementation and they were motivated when comprehending a text by means CSR strategy. Finally, the study proved that CSR improved students’ reading comprehension. Students’ mean score of reading test in the beginning of the study was 67, meanwhile, after applying CSR as reading strategy, their mean scores improved to 88.

  18. Iowa City Reads! The Reading Event Worth Shouting About.

    Science.gov (United States)

    Donham van Deusen, Jean; Langhorne, Mary Jo

    1997-01-01

    Describes the Community Reading Month (CRM) initiative in Iowa City, Iowa; its goals are to promote the value of reading and to build a sense of community. Topics include the development of CRM, increased reading scores of Iowa City's elementary school students, activities for people of all ages, and planning and evaluation. (AEF)

  19. Some implications of an experimental reading comprehension task

    Directory of Open Access Journals (Sweden)

    Lalović Dejan

    2008-01-01

    Full Text Available Standardized reading comprehension tests (RCTs are indispensable instruments in language abilities assessment. Nevertheless, we do not have such an instrument in Serbian. In the present paper, we attempted to verify the basic assumptions of the RCT conception we proposed: the reading material consisting of a relatively large selection of short newspaper articles followed by a single multiplechoice question each, displayed in temporal succession, not simultaneously. We argued that RCT consisting of such item form and content, as well as the administration procedure, should be of equal or even better construct validity than well-known RTCs in foreign languages, also possessing some other practical advantages. These assumptions were implemented in a computer-ran experimental reading comprehension task (ERCT, in a student sample. ERCT psychometric properties analyses showed good discriminability and somewhat less than preferable reliability. The structure and strength of ERCT x other intelligence tests correlations suggest ERCT belonging to the core of verbal abilities tests. Different strategies subjects employed showed no impact on major performance measure  number correct answers. Our findings obtained by ERCT implementation support the RCT conception we propose. We therefore suggest possible further research towards the construction of standardized RCT in Serbian.

  20. Metacognitive Reading Strategies, Motivation, and Reading Comprehension Performance of Saudi EFL Students

    Science.gov (United States)

    Meniado, Joel C.

    2016-01-01

    Metacognitive reading strategies and reading motivation play a significant role in enhancing reading comprehension. In an attempt to prove the foregoing claim in a context where there is no strong culture for reading, this study tries to find out if there is indeed a relationship between and among metacognitive reading strategies, reading…

  1. Reading Fluency and Students with Reading Disabilities: How Fast Is Fast Enough to Promote Reading Comprehension?

    Science.gov (United States)

    O'Connor, Rollanda E.

    2018-01-01

    The goal of improving reading rate and fluency is to positively impact reading comprehension; however, it is unclear how fast students with learning disabilities (LD) need to read to reap this benefit. The purpose of this research was to identify the point of diminishing return for students who were dysfluent readers. Participants included 337…

  2. Do students with Down syndrome have a specific learning profile for reading?

    Science.gov (United States)

    Ratz, Christoph

    2013-12-01

    The present study assessed achieved reading stages of 190 school-aged children with Down syndrome (DS, age 6-20) in Bavaria, one of the most populated federal states in Germany. Teachers described the reading stages of their students in a questionnaire. The achieved stages of reading according to the developmental model of Frith are compared to a sample of 1419 students with intellectual disability (ID) regardless of etiology, but excluding DS; thereafter parallelized ID-groups were compared. Results of the questionnaire addressed to the students' teachers showed that 20.2% of the students with DS do not read at all, 7.6% read at a logographic stage, 49.4% at an alphabetic and 22.8% at an orthographic level. Alongside these findings among the whole sample, correlations are described concerning age, gender, IQ and sociocultural background. The students with DS are then compared to other students with ID with mixed etiologies. This comparison stresses the emphasis on the alphabetic level amongst students with DS. This emphasis also exists when DS and non-DS students are parallelized in groups of ID, thus showing that students with DS and severe ID are ahead in reading, but those with mild ID are behind. Knowledge about specific literacy attainment of students with DS is vital for planning instruction, for creating learning environments, and for formulating future fields of research. Especially students with DS need specific teaching which takes their impaired verbal short term memory into account, such as learning to read in syllables. Copyright © 2013 Elsevier Ltd. All rights reserved.

  3. How do typographical factors affect reading text and comprehension performance in Arabic?

    Science.gov (United States)

    Ganayim, Deia; Ibrahim, Raphiq

    2013-04-01

    The objective of this study was to establish basic reading performance that could lead to useful design recommendations for print display text formats and layouts for the improvement of reading and comprehension performance of print text, such as academic writings, books, and newspapers, of Arabic language. Readability of English print text has been shown to be influenced by a number of typographical variables, including interline spacing, column setting and line length, and so on.Therefore, it is very important to improve the reading efficiency and satisfaction of print text reading and comprehension by following simple design guidelines. Most existing research on readability of print text is oriented to build guidelines for designing English texts rather than Arabic. However, guidelines built for English script cannot be simply applied for Arabic script because of orthographic differences. In the current study, manipulating interline spacing and column setting and line length generated nine text layouts. The reading and comprehension performance of 210 native Arab students assigned randomly to the different text layouts was compared. Results showed that the use of multicolumn setting (with medium or short line length) affected comprehension achievement but not reading and comprehension speed. Participants' comprehension scores were better for the single-column (with long line length) than for the multicolumn setting. However, no effect was found for interline spacing. The recommendations for appropriate print text format and layout in Arabic language based on the results of objective measures facilitating reading and comprehension performance is a single-column (with long line length) layout with no relevance of the interline spacing.

  4. The Relationship between Strategic Reading Instruction, Student Learning of L2-Based Reading Strategies and L2 Reading Achievement

    Science.gov (United States)

    Akkakoson, Songyut

    2013-01-01

    This study investigates the relationship between strategic reading instruction, the process of learning second language-based reading strategies and English reading achievement for Thai university students of science and technology. In a course in reading general English texts for 16?weeks, 82 students were taught using a strategies-based approach…

  5. Rapid and accurate determination of radiochemical purity of sup(99m)Tc compounds

    International Nuclear Information System (INIS)

    Tamat, S.R.

    1977-01-01

    The wide spread use of sup(99m)Tc-labelled radiopharmaceuticals and limitation of the short half-life of the isotope, is associated with an urgent need for a rapid, simple but accurate method for determining the radiochemical purity of the compound. A short paper chromatographic (KK) or thin layer chromatographic (KLT) method using 95% methanol or 0.9% saline solution as solvents, has solved the problem. With these methods, the amount of free sup(99m)Tc pertechnetate in a compound, can be determined in only a few minutes. These methods compare satisfactorily with lengtheir procedures. (author)

  6. Survey Guidelines and its Reading Criteria for Monitoring and Transmitting Cultural Heritage Values

    Directory of Open Access Journals (Sweden)

    A. De Masi

    2015-08-01

    Full Text Available The paper describes reading criteria for an analysis and interpretation of material systems in relation to a built space, survey guidelines and its reading criteria for Cultural Heritage (CH values’monitoring and transmission. In addition, integrated systems of digital technologies and 2D/3D digitization of CH are introduced for an effective and accurate reading of Venice and Milan’s monuments. Specifically, the guidelines for an architectural survey allow to organize and document historic monuments information, and to identify the significant cultural/physical elements of our past in order for them to be preserved and protected for future generations. In addition, in this paper the studied projects introduce a combination of virtual technologies and historical reality with experimenting innovative solutions for CH. From the methodological point of view, this study has made use of the identification of levels of study (LS differentiated, each of which is capable of identifying categories.

  7. Measurement of short bunches

    International Nuclear Information System (INIS)

    Wang, D.X.

    1996-01-01

    In recent years, there has been increasing interest in short electron bunches for different applications such as short wavelength FELs, linear colliders, and advanced accelerators such as laser or plasma wakefield accelerators. One would like to meet various requirements such as high peak current, low momentum spread, high luminosity, small ratio of bunch length to plasma wavelength, and accurate timing. Meanwhile, recent development and advances in RF photoinjectors and various bunching schemes make it possible to generate very short electron bunches. Measuring the longitudinal profile and monitoring bunch length are critical to understand the bunching process and longitudinal beam dynamics, and to commission and operate such short bunch machines. In this paper, several commonly used measurement techniques for subpicosecond bunches and their relative advantages and disadvantages are discussed. As examples, bunch length related measurements at Jefferson Lab are presented. At Jefferson Lab, bunch lengths as short as 84 fs have been systematically measured using a zero-phasing technique. A highly sensitive Coherent Synchrotron Radiation (CSR) detector has been developed to noninvasively monitor bunch length for low charge bunches. Phase transfer function measurements provide a means of correcting RF phase drifts and reproducing RF phases to within a couple of tenths of a degree. The measurement results are in excellent agreement with simulations. A comprehensive bunch length control scheme is presented. (author)

  8. Measurement of short bunches

    International Nuclear Information System (INIS)

    Wang, D.X.

    1996-01-01

    In recent years, there has been increasing interest in short electron bunches for different applications such as short wavelength FELs, linear colliders, and advanced accelerators such as laser or plasma wakefield accelerators. One would like to meet various requirements such as high peak current, low momentum spread, high luminosity, small ratio of bunch length to plasma wavelength, and accurate timing. Meanwhile, recent development and advances in RF photoinjectors and various bunching schemes make it possible to generate very short electron bunches. Measuring the longitudinal profile and monitoring bunch length are critical to understand the bunching process and longitudinal beam dynamics, and to commission and operate such short bunch machines. In this paper, several commonly used measurement techniques for subpicosecond bunches and their relative advantages and disadvantages are discussed. As examples, bunch length related measurements at Jefferson lab are presented. At Jefferson Lab, bunch lengths s short as 84 fs have been systematically measured using a zero-phasing technique. A highly sensitive Coherent Synchrotron Radiation (CSR) detector has been developed to noninvasively monitor bunch length for low charge bunches. Phase transfer function measurements provide a means of correcting RF phase drifts and reproducing RF phases to within a couple of tenths of a degree. The measurement results are in excellent agreement with simulations. A comprehensive bunch length control scheme is presented

  9. The Effect of Modified Collaborative Strategic Reading on EFL Learners' Reading Anxiety

    Directory of Open Access Journals (Sweden)

    Shabnam Abbasnezhad

    2016-12-01

    Full Text Available The present study was an attempt to investigate the effectiveness of reading instructional approach called MCSR- Modified Collaborative Strategic Reading on reducing intermediate EFL learner's reading anxiety. Based on a pretest-posttest design, MCSR was implemented with 64 EFL learners at intermediate level. They received EFL reading instruction according to MCSR over two and a half months. A questionnaire called English as a Foreign Language Reading Anxiety Inventory EFLRAI was group-administered atthepretest and the posttest. Quantitative results indicated that participating students demonstrated significant gains in reducing reading anxiety. This study highlighted our understanding by considering the effectiveness of MCSR program and also it elaborated the effects of using strategies like MCSR in overcoming the big problem of reading anxiety among EFL learners as non-native students. And teachers changed the focus of attention from using traditional methods for teaching the essential skill of reading to modern programs like MCSR in order to remove their students' anxiety and stress in reading.

  10. The Effect of Baby Books on Mothers’ Reading Beliefs and Reading Practices

    Science.gov (United States)

    Auger, Anamarie; Reich, Stephanie M.; Penner, Emily K.

    2014-01-01

    The impact of a baby book intervention on promoting positive reading beliefs and increasing reading frequency for low-income, new mothers (n = 167) was examined. The Baby Books Project randomly assigned low-income, first-time mothers to one of three study conditions, receiving educational books, non-educational books, or no books, during pregnancy and over the first year of parenthood. Home-based data collection occurred through pregnancy until 18 months post-partum. Mothers who received free baby books had higher beliefs about the importance of reading, the value of having resources to support reading, and the importance of verbal participation during reading. The results showed that providing any type of baby books to mothers positively influenced maternal reading beliefs, but did not increase infant-mother reading practices. Maternal reading beliefs across all three groups were significantly associated with self-reported reading frequency when children were at least 12 months of age. PMID:25264394

  11. Close Reading and Creative Writing in Clinical Education: Teaching Attention, Representation, and Affiliation.

    Science.gov (United States)

    Charon, Rita; Hermann, Nellie; Devlin, Michael J

    2016-03-01

    Medical educators increasingly have embraced literary and narrative means of pedagogy, such as the use of learning portfolios, reading works of literature, reflective writing, and creative writing, to teach interpersonal and reflective aspects of medicine. Outcomes studies of such pedagogies support the hypotheses that narrative training can deepen the clinician's attention to a patient and can help to establish the clinician's affiliation with patients, colleagues, teachers, and the self. In this article, the authors propose that creative writing in particular is useful in the making of the physician. Of the conceptual frameworks that explain why narrative training is helpful for clinicians, the authors focus on aesthetic theories to articulate the mechanisms through which creative and reflective writing may have dividends in medical training. These theories propose that accurate perception requires representation and that representation requires reception, providing a rationale for teaching clinicians and trainees how to represent what they perceive in their clinical work and how to read one another's writings. The authors then describe the narrative pedagogy used at the College of Physicians and Surgeons of Columbia University. Because faculty must read what their students write, they receive robust training in close reading. From this training emerged the Reading Guide for Reflective Writing, which has been useful to clinicians as they develop their skills as close readers. This institution-wide effort to teach close reading and creative writing aims to equip students and faculty with the prerequisites to provide attentive, empathic clinical care.

  12. Close Reading and Creative Writing in Clinical Education: Teaching Attention, Representation, and Affiliation

    Science.gov (United States)

    Charon, Rita; Hermann, Nellie; Devlin, Michael J.

    2015-01-01

    Medical educators increasingly have embraced literary and narrative means of pedagogy, such as the use of learning portfolios, reading works of literature, reflective writing, and creative writing, to teach interpersonal and reflective aspects of medicine. Outcomes studies of such pedagogies support the hypotheses that narrative training can deepen the clinician's attention to a patient and can help to establish the clinician's affiliation with patients, colleagues, teachers, and the self. In this article, the authors propose that creative writing in particular is useful in the making of the physician. Of the conceptual frameworks that explain why narrative training is helpful for clinicians, the authors focus on aesthetic theories to articulate the mechanisms through which creative and reflective writing may have dividends in medical training. These theories propose that accurate perception requires representation and that representation requires reception, providing a rationale for teaching clinicians and trainees how to represent what they perceive in their clinical work and how to read one another's writings. The authors then describe the narrative pedagogy used at the College of Physicians and Surgeons of Columbia University. Since faculty must read what their students write, they receive robust training in close reading. From this training emerged the Reading Guide for Reflective Writing, which has been useful to clinicians as they develop their skills as close readers. This institution-wide effort to teach close reading and creative writing aims to equip students and faculty with the pre-requisites to provide attentive, empathic clinical care. PMID:26200577

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

  14. Pre-reading activities in EFL/ESL reading textbooks and Turkish preparatory school teachers' attitudes toward pre-reading activities

    OpenAIRE

    Jecksembieyva, Nurgaisha

    1993-01-01

    Ankara : Faculty of Humanities and Letters and the Institute of Economics and Social Sciences of Bilkent University, 1993. Thesis (Master's) -- -Bilkent University, 1993. Includes bibliographical references leaves 35-40. The main focus of this study was to investigate pre-reading activities in EFL/ESL reading textbooks and to determine teachers' attitudes toward pre-reading activities. Fifteen reading textbooks for EFL/ESL students for different proficiency levels (beginning, interm...

  15. Development of a Case-based Reading Curriculum and Its Effect on Resident Reading.

    Science.gov (United States)

    Messman, Anne M; Walker, Ian

    2018-01-01

    Textbook reading plays a foundational role in a resident's knowledge base. Many residency programs place residents on identical reading schedules, regardless of the clinical work or rotation the resident is doing. We sought to develop a reading curriculum that takes into account the clinical work a resident is doing so their reading curriculum corresponds with their clinical work. Preliminary data suggests an increased amount of resident reading and an increased interest in reading as a result of this change to their reading curriculum.

  16. Reading and Language Intervention for Children at Risk of Dyslexia: A Randomised Controlled Trial

    Science.gov (United States)

    Duff, Fiona J.; Hulme, Charles; Grainger, Katy; Hardwick, Samantha J.; Miles, Jeremy N. V.; Snowling, Margaret J.

    2014-01-01

    Background: Intervention studies for children at risk of dyslexia have typically been delivered preschool, and show short-term effects on letter knowledge and phoneme awareness, with little transfer to literacy. Methods: This randomised controlled trial evaluated the effectiveness of a reading and language intervention for 6-year-old children…

  17. Fast and accurate edge orientation processing during object manipulation

    Science.gov (United States)

    Flanagan, J Randall; Johansson, Roland S

    2018-01-01

    Quickly and accurately extracting information about a touched object’s orientation is a critical aspect of dexterous object manipulation. However, the speed and acuity of tactile edge orientation processing with respect to the fingertips as reported in previous perceptual studies appear inadequate in these respects. Here we directly establish the tactile system’s capacity to process edge-orientation information during dexterous manipulation. Participants extracted tactile information about edge orientation very quickly, using it within 200 ms of first touching the object. Participants were also strikingly accurate. With edges spanning the entire fingertip, edge-orientation resolution was better than 3° in our object manipulation task, which is several times better than reported in previous perceptual studies. Performance remained impressive even with edges as short as 2 mm, consistent with our ability to precisely manipulate very small objects. Taken together, our results radically redefine the spatial processing capacity of the tactile system. PMID:29611804

  18. Development of a Case-based Reading Curriculum and Its Effect on Resident Reading

    Directory of Open Access Journals (Sweden)

    Anne M. Messman

    2017-12-01

    Full Text Available Textbook reading plays a foundational role in a resident’s knowledge base. Many residency programs place residents on identical reading schedules, regardless of the clinical work or rotation the resident is doing. We sought to develop a reading curriculum that takes into account the clinical work a resident is doing so their reading curriculum corresponds with their clinical work. Preliminary data suggests an increased amount of resident reading and an increased interest in reading as a result of this change to their reading curriculum.

  19. Reading Comprehension Strategies

    Directory of Open Access Journals (Sweden)

    Unal Ulker

    2017-12-01

    Full Text Available The academic success of the university students greatly depends on the mastery of an academic reading skill. However, students as well as teachers, take the learning of this skill for granted, as they tend to presuppose that reading skill is acquired as a part of their secondary education. As a result, most first-year students employ non university strategies to read academic texts, which leads to a surface approach to reading and prevents students from a better understanding of the material. This paper will discuss the strategies that involve students in taking a deep approach to reading academic texts.

  20. Early reading intervention by means of a multicomponent reading game

    NARCIS (Netherlands)

    Ven, M.A.M. van de; Leeuw, L.C. de; Weerdenburg, M.W.C. van; Steenbeek-Planting, E.G.

    2017-01-01

    This study examined the effects of an intervention with a multicomponent reading game on the development of reading skills in 60 Dutch primary school children with special educational needs. The game contains evidence-based reading exercises and is based on principles of applied gaming. Using a

  1. Reading-Related Causal Attributions for Success and Failure: Dynamic Links With Reading Skill.

    Science.gov (United States)

    Frijters, Jan C; Tsujimoto, Kimberley C; Boada, Richard; Gottwald, Stephanie; Hill, Dina; Jacobson, Lisa A; Lovett, Maureen W; Mahone, E Mark; Willcutt, Erik G; Wolf, Maryanne; Bosson-Heenan, Joan; Gruen, Jeffrey R

    2018-01-01

    The present study investigated the relation among reading skills and attributions, naming speed, and phonological awareness across a wide range of reading skill. Participants were 1,105 school-age children and youths from two understudied populations: African Americans and Hispanic Americans. Individual assessments of children ranging in age from 8 to 15 years were conducted for reading outcomes, cognitive and linguistic predictors of reading, and attributions for success and failure in reading situations. Quantile regressions were formulated to estimate these relations across the full skill span of each outcome. Reading-related attributions predicted contextual word recognition, sight word and decoding fluency, and comprehension skills. Attributions to ability in success situations were positively related to each outcome across the full span. On three reading outcomes, this relation strengthened at higher skill levels. Attributions to effort in success situations were consistently and negatively related to all reading outcomes. The results provide evidence that the strength of the relation between reading and attributions varies according to reading skill levels, with the strongest evidence for ability-based attributions in situations of reading success.

  2. A glance at quality score: implication for de novo transcriptome reconstruction of Illumina reads

    Directory of Open Access Journals (Sweden)

    Stanley Kimbung Mbandi

    2014-02-01

    Full Text Available Downstream analyses of short-reads from next-generation sequencing platforms are often preceded by a pre-processing step that removes uncalled and wrongly called bases. Standard approaches rely on their associated base quality scores to retain the read or a portion of it when the score is above a predefined threshold. It is difficult to differentiate sequencing error from biological variation without a reference using quality scores. The effects of quality score based trimming have not been systematically studied in de novo transcriptome assembly. Using RNA-Seq data produced from Illumina, we teased out the effects of quality score base filtering or trimming on de novo transcriptome reconstruction. We showed that assemblies produced from reads subjected to different quality score thresholds contain truncated and missing transfrags when compared to those from untrimmed reads. Our data supports the fact that de novo assembling of untrimmed data is challenging for de Bruijn graph assemblers. However, our results indicates that comparing the assemblies from untrimmed and trimmed read subsets can suggest appropriate filtering parameters and enable selection of the optimum de novo transcriptome assembly in non-model organisms.

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

  4. Wechsler Intelligence Scale for Children-fourth edition (WISC-IV) short-form validity: a comparison study in pediatric epilepsy.

    Science.gov (United States)

    Hrabok, Marianne; Brooks, Brian L; Fay-McClymont, Taryn B; Sherman, Elisabeth M S

    2014-01-01

    The purpose of this article was to investigate the accuracy of the WISC-IV short forms in estimating Full Scale Intelligence Quotient (FSIQ) and General Ability Index (GAI) in pediatric epilepsy. One hundred and four children with epilepsy completed the WISC-IV as part of a neuropsychological assessment at a tertiary-level children's hospital. The clinical accuracy of eight short forms was assessed in two ways: (a) accuracy within +/- 5 index points of FSIQ and (b) the clinical classification rate according to Wechsler conventions. The sample was further subdivided into low FSIQ (≤ 80) and high FSIQ (> 80). All short forms were significantly correlated with FSIQ. Seven-subtest (Crawford et al. [2010] FSIQ) and 5-subtest (BdSiCdVcLn) short forms yielded the highest clinical accuracy rates (77%-89%). Overall, a 2-subtest (VcMr) short form yielded the lowest clinical classification rates for FSIQ (35%-63%). The short form yielding the most accurate estimate of GAI was VcSiMrBd (73%-84%). Short forms show promise as useful estimates. The 7-subtest (Crawford et al., 2010) and 5-subtest (BdSiVcLnCd) short forms yielded the most accurate estimates of FSIQ. VcSiMrBd yielded the most accurate estimate of GAI. Clinical recommendations are provided for use of short forms in pediatric epilepsy.

  5. A new sentence generator providing material for maximum reading speed measurement.

    Science.gov (United States)

    Perrin, Jean-Luc; Paillé, Damien; Baccino, Thierry

    2015-12-01

    A new method is proposed to generate text material for assessing maximum reading speed of adult readers. The described procedure allows one to generate a vast number of equivalent short sentences. These sentences can be displayed for different durations in order to determine the reader's maximum speed using a psychophysical threshold algorithm. Each sentence is built so that it is either true or false according to common knowledge. The actual reading is verified by asking the reader to determine the truth value of each sentence. We based our design on the generator described by Crossland et al. and upgraded it. The new generator handles concepts distributed in an ontology, which allows an easy determination of the sentences' truth value and control of lexical and psycholinguistic parameters. In this way many equivalent sentence can be generated and displayed to perform the measurement. Maximum reading speed scores obtained with pseudo-randomly chosen sentences from the generator were strongly correlated with maximum reading speed scores obtained with traditional MNREAD sentences (r = .836). Furthermore, the large number of sentences that can be generated makes it possible to perform repeated measurements, since the possibility of a reader learning individual sentences is eliminated. Researchers interested in within-reader performance variability could use the proposed method for this purpose.

  6. Exploration and exploitation of Victorian science in Darwin's reading notebooks.

    Science.gov (United States)

    Murdock, Jaimie; Allen, Colin; DeDeo, Simon

    2017-02-01

    Search in an environment with an uncertain distribution of resources involves a trade-off between exploitation of past discoveries and further exploration. This extends to information foraging, where a knowledge-seeker shifts between reading in depth and studying new domains. To study this decision-making process, we examine the reading choices made by one of the most celebrated scientists of the modern era: Charles Darwin. From the full-text of books listed in his chronologically-organized reading journals, we generate topic models to quantify his local (text-to-text) and global (text-to-past) reading decisions using Kullback-Liebler Divergence, a cognitively-validated, information-theoretic measure of relative surprise. Rather than a pattern of surprise-minimization, corresponding to a pure exploitation strategy, Darwin's behavior shifts from early exploitation to later exploration, seeking unusually high levels of cognitive surprise relative to previous eras. These shifts, detected by an unsupervised Bayesian model, correlate with major intellectual epochs of his career as identified both by qualitative scholarship and Darwin's own self-commentary. Our methods allow us to compare his consumption of texts with their publication order. We find Darwin's consumption more exploratory than the culture's production, suggesting that underneath gradual societal changes are the explorations of individual synthesis and discovery. Our quantitative methods advance the study of cognitive search through a framework for testing interactions between individual and collective behavior and between short- and long-term consumption choices. This novel application of topic modeling to characterize individual reading complements widespread studies of collective scientific behavior. Copyright © 2016 Elsevier B.V. All rights reserved.

  7. Preservation of memory-based automaticity in reading for older adults.

    Science.gov (United States)

    Rawson, Katherine A; Touron, Dayna R

    2015-12-01

    Concerning age-related effects on cognitive skill acquisition, the modal finding is that older adults do not benefit from practice to the same extent as younger adults in tasks that afford a shift from slower algorithmic processing to faster memory-based processing. In contrast, Rawson and Touron (2009) demonstrated a relatively rapid shift to memory-based processing in the context of a reading task. The current research extended beyond this initial study to provide more definitive evidence for relative preservation of memory-based automaticity in reading tasks for older adults. Younger and older adults read short stories containing unfamiliar noun phrases (e.g., skunk mud) followed by disambiguating information indicating the combination's meaning (either the normatively dominant meaning or an alternative subordinate meaning). Stories were repeated across practice blocks, and then the noun phrases were presented in novel sentence frames in a transfer task. Both age groups shifted from computation to retrieval after relatively few practice trials (as evidenced by convergence of reading times for dominant and subordinate items). Most important, both age groups showed strong evidence for memory-based processing of the noun phrases in the transfer task. In contrast, older adults showed minimal shifting to retrieval in an alphabet arithmetic task, indicating that the preservation of memory-based automaticity in reading was task-specific. Discussion focuses on important implications for theories of memory-based automaticity in general and for specific theoretical accounts of age effects on memory-based automaticity, as well as fruitful directions for future research. (c) 2015 APA, all rights reserved).

  8. The role of short-term memory impairment in nonword repetition, real word repetition, and nonword decoding: A case study.

    Science.gov (United States)

    Peter, Beate

    2018-01-01

    In a companion study, adults with dyslexia and adults with a probable history of childhood apraxia of speech showed evidence of difficulty with processing sequential information during nonword repetition, multisyllabic real word repetition and nonword decoding. Results suggested that some errors arose in visual encoding during nonword reading, all levels of processing but especially short-term memory storage/retrieval during nonword repetition, and motor planning and programming during complex real word repetition. To further investigate the role of short-term memory, a participant with short-term memory impairment (MI) was recruited. MI was confirmed with poor performance during a sentence repetition and three nonword repetition tasks, all of which have a high short-term memory load, whereas typical performance was observed during tests of reading, spelling, and static verbal knowledge, all with low short-term memory loads. Experimental results show error-free performance during multisyllabic real word repetition but high counts of sequence errors, especially migrations and assimilations, during nonword repetition, supporting short-term memory as a locus of sequential processing deficit during nonword repetition. Results are also consistent with the hypothesis that during complex real word repetition, short-term memory is bypassed as the word is recognized and retrieved from long-term memory prior to producing the word.

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

  10. How do children read words? A focus on reading processes

    NARCIS (Netherlands)

    van den Boer, M.

    2014-01-01

    Being able to read is very important in our literate society. Many studies, therefore, have examined children’s reading skills to improve our understanding of reading development. In general, there have been two types of studies. On the one hand, there is a line of research that focuses on the

  11. ELL High School Students' Metacognitive Awareness of Reading Strategy Use and Reading Proficiency

    Science.gov (United States)

    Hong-Nam, Kay

    2014-01-01

    This study investigated the metacognitive awareness and reading strategies use of high school-­aged English language learners (ELLs) and the relationship between ELL reading strategy use and reading proficiency as measured by a standardized reading test and self-­rated reading proficiency. Results reveal that participants reported moderate use of…

  12. Rearing a reading habit

    OpenAIRE

    Sridhar, M. S.

    2009-01-01

    Discusses the importance and ways of inculcating reading habit in children at the right age, describes the five reading phases in children along with interest and the material to satiate the need, explains how four deterministic factors affect the reading habit of children, enlists motivations that are behind the reading process with tips to improve reading habit of children.

  13. Effects of Listening While Reading (LWR on Swahili Reading Fluency and Comprehension

    Directory of Open Access Journals (Sweden)

    Filipo Lubua

    2016-10-01

    Full Text Available A number of studies have examined the contribution of technology in teaching such languages as English, French, and Spanish, among many others. Contrarily, most LCTL’s, have received very little attention. This study investigates if listening while reading (LWR may expedite Swahili reading fluency and comprehension. The study employed the iBook Author tool to create weekly mediated and interactive reading texts, with comprehension exercises, which were eventually used to collect descriptive and qualitative data from four Elementary Swahili students. Participants participated in a seven week reading program, which provided them with some kind of directed self-learning, and met with the instructor for at least 30 minutes every week for observation and more reading activities. The teacher recorded their reading scores, and a number of themes on how LWR influenced reading fluency and comprehension are discussed here. It shows that participants have a positive attitude towards LWR and they suggest it for all the reading classes.

  14. The Effects of Visual Attention Span and Phonological Decoding in Reading Comprehension in Dyslexia: A Path Analysis.

    Science.gov (United States)

    Chen, Chen; Schneps, Matthew H; Masyn, Katherine E; Thomson, Jennifer M

    2016-11-01

    Increasing evidence has shown visual attention span to be a factor, distinct from phonological skills, that explains single-word identification (pseudo-word/word reading) performance in dyslexia. Yet, little is known about how well visual attention span explains text comprehension. Observing reading comprehension in a sample of 105 high school students with dyslexia, we used a pathway analysis to examine the direct and indirect path between visual attention span and reading comprehension while controlling for other factors such as phonological awareness, letter identification, short-term memory, IQ and age. Integrating phonemic decoding efficiency skills in the analytic model, this study aimed to disentangle how visual attention span and phonological skills work together in reading comprehension for readers with dyslexia. We found visual attention span to have a significant direct effect on more difficult reading comprehension but not on an easier level. It also had a significant direct effect on pseudo-word identification but not on word identification. In addition, we found that visual attention span indirectly explains reading comprehension through pseudo-word reading and word reading skills. This study supports the hypothesis that at least part of the dyslexic profile can be explained by visual attention abilities. Copyright © 2016 John Wiley & Sons, Ltd. Copyright © 2016 John Wiley & Sons, Ltd.

  15. Annual research review: the nature and classification of reading disorders--a commentary on proposals for DSM-5.

    Science.gov (United States)

    Snowling, Margaret J; Hulme, Charles

    2012-05-01

    This article reviews our understanding of reading disorders in children and relates it to current proposals for their classification in DSM-5. There are two different, commonly occurring, forms of reading disorder in children which arise from different underlying language difficulties. Dyslexia (as defined in DSM-5), or decoding difficulty, refers to children who have difficulty in mastering the relationships between the spelling patterns of words and their pronunciations. These children typically read aloud inaccurately and slowly, and experience additional problems with spelling. Dyslexia appears to arise principally from a weakness in phonological (speech sound) skills, and there is good evidence that it can be ameliorated by systematic phonic teaching combined with phonological awareness training. The other major form of reading difficulty is reading comprehension impairment. These children read aloud accurately and fluently, but have difficulty understanding what they have read. Reading comprehension impairment appears to arise from weaknesses in a range of oral language skills including poor vocabulary knowledge, weak grammatical skills and difficulties in oral language comprehension. We suggest that the omission of reading comprehension impairment from DSM-5 is a serious one that should be remedied. Both dyslexia and reading comprehension impairment are dimensional in nature, and show strong continuities with other disorders of language. We argue that recognizing the continuities between reading and language disorders has important implications for assessment and treatment, and we note that the high rates of comorbidity between reading disorders and other seemingly disparate disorders (including ADHD and motor disorders) raises important challenges for understanding these disorders. © 2011 The Authors. Journal of Child Psychology and Psychiatry © 2011 Association for Child and Adolescent Mental Health.

  16. Influence of reading habits on cerebral plasticity for discourse comprehension in aging

    Directory of Open Access Journals (Sweden)

    Charles-Olivier Martin

    2012-12-01

    Full Text Available http://dx.doi.org/10.5007/2175-8026.2012n63p101   The goal of this study was to evaluate the influence of reading habits on cerebral plasticity in the performance of a discourse comprehension task in aging. The main hypothesis was that participants with higher frequency and quality of reading habits should exhibit reduced brain activity because the task should be easier for them. two groups of native French speakers, 16 young adults and 16 elderly adults, participated in a task using the nirS (near-infrared spectroscopy technique. They read short stories and answered true or false probes after each one. They also completed a questionnaire about their previous reading habits. The results show that the more experienced readers had higher activation in the superior left region of the prefrontal cortex while they were reading the stories but lower activation in the same region when they were retrieving the information to answer the probe. Thus, more effort is required to acquire and maintain the information needed to answer, and this effort makes it easier to give the answer. These results reinforce the hypothesis that brain plasticity is promoted by cognitive activities throughout the lifespan.

  17. Reading Fluency Instruction for Students at Risk for Reading Failure

    Science.gov (United States)

    Ring, Jeremiah J.; Barefoot, Lexie C.; Avrit, Karen J.; Brown, Sasha A.; Black, Jeffrey L.

    2013-01-01

    The important role of reading fluency in the comprehension and motivation of readers is well documented. Two reading rate intervention programs were compared in a cluster-randomized clinical trial of students who were considered at-risk for reading failure. One program focused instruction at the word level; the second program focused instruction…

  18. Early Reading Intervention by Means of a Multicomponent Reading Game

    Science.gov (United States)

    van de Ven, M.; de Leeuw, L.; van Weerdenburg, M.; Steenbeek-Planting, E. G.

    2017-01-01

    This study examined the effects of an intervention with a multicomponent reading game on the development of reading skills in 60 Dutch primary school children with special educational needs. The game contains evidence-based reading exercises and is based on principles of applied gaming. Using a multiple baseline approach, we tested children's…

  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. Development of reading comprehension with graphic organizers for students with dyslexia

    Directory of Open Access Journals (Sweden)

    Jacqueline Lopez

    2018-04-01

    Full Text Available The executed research will permit the creation and design of a handbook with easy-to-read stories that would increase their receptive abilities in a foreign language in the learning process of students with learning disabilities (dyslexia. This academic work has also the aim of analyzing the impact of graphic organizers in the development of reading comprehension accordance  with the level of English of each student. The theoretical foundation is constructed by the contents previously defined in the problem; with specific bibliography for the scientific content. Statistical analyses of information were taken into consideration. These analyses determined the importance of the implementation of a handbook that would include a short and a long text, vocabulary in context, strategies to improve reading skills, and unit assessments to evaluate the knowledge of students in each unit. This will let the students to develop multiple skills with the guidance of the teacher. This innovative material has as a main target to help the learner to decode phonemes and to identify structures of the story through charts and pictures.

  1. STUDENTS’ READING PRACTICES AND ENVIRONMENTS

    Directory of Open Access Journals (Sweden)

    Aiza Johari

    2013-07-01

    Full Text Available Abstract: The challenges of reading are indeed apparent in most teaching and learning processes in ESL classrooms. As a result, this study is conducted to resolve the issues of students who seem to find reading to be unbearable. Many of them have limited ability to read well and hence, possess insufficient reading habits to become competent readers, particularly out-of-school context. Besides, poor home literacy environments also contribute to their shortcomings in reading. The main objectives of this study are to identify the students’ reasons for reading as well as to find out their home reading environments (reading backgrounds and habits; reading attitudes and motivation; reading exposure and supports. To identify these, questionnaires were distributed to 120 secondary school students (Form 4: 16 years old from one of the urban schools in Sarawak, Malaysia. The findings indicate that the students read to gain information and knowledge though many chose reading as a hobby as their last choice in explaining their motives of reading. Besides, they preferred non-academic reading materials, mainly lighter forms reading materials such as comics, story books and magazines. Though the students acknowledged the importance of reading in their daily lives, their average reading habits, attitude, motivation, exposure and support within the home domain had suggested otherwise. They mainly read for instrumental purposes while reading for pleasure seemed not to be given priority. Besides, the respondents acknowledge that their parents and themselves did not read much at home. As an implication, it is vital for students to improve their reading perceptions, abilities and practices to achieve personal, societal and national progress. On a final note, parents’ early and continuous efforts to be involved in their children’s literacy events in an out-of-school context are believed to be vital to inculcate positive reading environments, habits and culture

  2. A Comparison of the Interest Accuracy of Two Short Forms of the WAIS-R.

    Science.gov (United States)

    Cella, David F.; And Others

    1985-01-01

    Examined relative efficacy of two short forms of Wechsler Adult Intelligence Scale-Revised (WAIS-R) with respect to accurate subtest profile scatter (N=50). Subtest scores of both split-half Satz-Mogel short form and criterion referenced Modified WAIS-R (WAIS-RM) short form were found to differ significantly from full-length WAIS-R subtest scores.…

  3. Deaf Children's Use of Phonological Coding: Evidence from Reading, Spelling, and Working Memory

    Science.gov (United States)

    Harris, Margaret; Moreno, Constanza

    2004-01-01

    Two groups of deaf children, aged 8 and 14 years, were presented with a number of tasks designed to assess their reliance on phonological coding. Their performance was compared with that of hearing children of the same chronological age (CA) and reading age (RA). Performance on the first task, short-term recall of pictures, showed that the deaf…

  4. Measuring adult literacy students' reading skills using the Gray Oral Reading Test.

    Science.gov (United States)

    Greenberg, Daphne; Pae, Hye Kyeong; Morris, Robin D; Calhoon, Mary Beth; Nanda, Alice O

    2009-12-01

    There are not enough reading tests standardized on adults who have very low literacy skills, and therefore tests standardized on children are frequently administered. This study addressed the complexities and problems of using a test normed on children to measure the reading comprehension skills of 193 adults who read at approximately third through fifth grade reading grade equivalency levels. Findings are reported from an analysis of the administration of Form A of the Gray Oral Reading Tests-Fourth Edition (Wiederholt & Bryant, 2001a, b). Results indicated that educators and researchers should be very cautious when interpreting test results of adults who have difficulty reading when children's norm-referenced tests are administered.

  5. Reading: United States.

    Science.gov (United States)

    Weber, Rose-Marie

    1983-01-01

    An exploration of the increasingly important role of linguistics in literacy research and instruction reviews literature on reading comprehension, written language, orthography, metalinguistics, classroom language use, reading disabilities, native tongues, nonstandard dialects, bilingual education, adult literacy, and second-language reading. (86…

  6. Exploring Content Schemata Influence on L2 Reading: The Hunted Fox and Twelve and Not Stupid

    Directory of Open Access Journals (Sweden)

    Amizura Hanadi Mohd Radzi

    2014-10-01

    Full Text Available This paper will discuss the aspects of content schemata in second language reading among diploma level students who were taking a reading course in Universiti Teknologi MARA Perlis. In this qualitative case study, the researcher had selected two short stories that are categorized as content-familiar texts, i.e. The Hunted Fox and Twelve and Not Stupid. Six participants were asked to write a 150-word entry response on the short story and a grading criteria was used to assess the participants’ level of comprehension. An in-depth interview was also conducted on each participant. The entry responses and the interview patterns were analyzed to determine whether content schemata had contributed to the learners’ understanding of the text. This study discovered that content schemata had contributed to the learners’ understanding of the text because the learners’ comprehension was facilitated by their background knowledge on the content-familiar texts.

  7. How old are you—Evaluation of age reading methods for the invasive round goby (Neogobius melanostomus, Pallas 1814)

    DEFF Research Database (Denmark)

    Florin, Ann-Britt; Hüssy, Karin; Blass, M.

    2018-01-01

    for an increasing knowledge of their basic stock structures such as growth rates, longevity and mortality, which all rely on accurate estimates of age. Former studies on the round goby have used several different age reading techniques. In this study, we compared three standard otolith preparation methods...... agreement was lowest when reading the whole otoliths while the best performance was achieved with sectioned and stained preparation method. Depending on method used the growth estimates also differed. The results question comparability between previous studies and highlight the importance of harmonised...

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

  9. Reading Disabilities and PASS Reading Enhancement Programme

    Science.gov (United States)

    Mahapatra, Shamita

    2016-01-01

    Children experience difficulties in reading either because they fail to decode the words and thus are unable to comprehend the text or simply fail to comprehend the text even if they are able to decode the words and read them out. Failure in word decoding results from a failure in phonological coding of written information, whereas reading…

  10. The Effect of Collaborative Strategic Reading on Grade Six Students’ Reading Achievement

    Directory of Open Access Journals (Sweden)

    Siti Tamah

    2016-01-01

    Full Text Available One of the language skills to master by Indonesian EFL learners is reading. In order to assist learners comprehend reading texts, teachers are challenged to apply various teaching strategies. As this paper focuses on teaching reading, two teaching strategies dealing with reading instruction are compared. To be specific, in this paper the writers conduct a study to find the difference between Collaborative Strategic Reading (CSR and teacher-centered teaching strategy (by applying skimming and scanning. This study was a quasi experimental, which was conducted upon the sixth graders of an elementary school. The finding showed that reading achievements of the students who are taught using CSR and teacher-centered teaching strategy are not significantly different. Nevertheless, this study using Cohen’s d formula finds that CSR gave a small effect on students’ reading achievement.

  11. Cognitive precursors of the developmental relation between lexical quality and reading comprehension in the intermediate elementary grades

    NARCIS (Netherlands)

    Swart, N.M.; Muijselaar, M.M.L.; Steenbeek-Planting, E.G.; Droop, W.; Jong, P.F. de; Verhoeven, L.T.W.

    2017-01-01

    In a longitudinal study, we investigated how cognitive precursors (short-term memory, working memory, and nonverbal reasoning) influence the developmental relation between lexical quality (decoding and vocabulary) and reading comprehension skill in 282 Dutch students in the intermediate elementary

  12. Cognitive precursors of the developmental relation between lexical quality and reading comprehension in the intermediate elementary grades.

    NARCIS (Netherlands)

    Swart, N.M.; Muijselaar, M.M.L.; Steenbeek-Planting, E.G.; Droop, M.; de Jong, P.F.; Verhoeven, L.

    2017-01-01

    In a longitudinal study, we investigated how cognitive precursors (short-term memory, working memory, and nonverbal reasoning) influence the developmental relation between lexical quality (decoding and vocabulary) and reading comprehension skill in 282 Dutch students in the intermediate elementary

  13. L2 Reading in Thailand: Vocational College Students' Application of Reading Strategies to Their Reading of English Texts

    Science.gov (United States)

    Kasemsap, Bharani; Lee, Hugo Yu-Hsiu

    2015-01-01

    This study aims to explore the application of reading strategies to the reading of English texts by Thai vocational college students. Data were collected via questionnaire surveys, think-aloud experiments and semi-structured interviews. The research results reveal different typologies of reading strategies adopted by lower and higher level English…

  14. The economic value of accurate wind power forecasting to utilities

    Energy Technology Data Exchange (ETDEWEB)

    Watson, S J [Rutherford Appleton Lab., Oxfordshire (United Kingdom); Giebel, G; Joensen, A [Risoe National Lab., Dept. of Wind Energy and Atmospheric Physics, Roskilde (Denmark)

    1999-03-01

    With increasing penetrations of wind power, the need for accurate forecasting is becoming ever more important. Wind power is by its very nature intermittent. For utility schedulers this presents its own problems particularly when the penetration of wind power capacity in a grid reaches a significant level (>20%). However, using accurate forecasts of wind power at wind farm sites, schedulers are able to plan the operation of conventional power capacity to accommodate the fluctuating demands of consumers and wind farm output. The results of a study to assess the value of forecasting at several potential wind farm sites in the UK and in the US state of Iowa using the Reading University/Rutherford Appleton Laboratory National Grid Model (NGM) are presented. The results are assessed for different types of wind power forecasting, namely: persistence, optimised numerical weather prediction or perfect forecasting. In particular, it will shown how the NGM has been used to assess the value of numerical weather prediction forecasts from the Danish Meteorological Institute model, HIRLAM, and the US Nested Grid Model, which have been `site tailored` by the use of the linearized flow model WA{sup s}P and by various Model output Statistics (MOS) and autoregressive techniques. (au)

  15. Short forms of the Social Interaction Anxiety Scale and the Social Phobia Scale.

    Science.gov (United States)

    Fergus, Thomas A; Valentiner, David P; McGrath, Patrick B; Gier-Lonsway, Stephanie L; Kim, Hyun-Soo

    2012-01-01

    Mattick and Clarke's (1998) Social Interaction Anxiety Scale (SIAS) and Social Phobia Scale (SPS) are commonly used self-report measures that assess 2 dimensions of social anxiety. Given the need for short, readable measures, this research proposes short forms of both scales. Item-level analyses of readability characteristics of the SIAS and SPS items led to the selection of 6 items from each scale for use in the short forms. The SIAS and SPS short forms had reading levels at approximately the 6th and 5th grade level, respectively. Results using nonclinical (Study 1: N = 469) and clinical (Study 2: N = 145) samples identified these short forms as being factorially sound, possessing adequate internal consistency, and having strong convergence with their full-length counterparts. Moreover, these short forms showed convergence with other measures of social anxiety, showed divergence from measures assessing related constructs, and predicted concurrent interpersonal functioning. Recommendations for the use of these short forms are discussed.

  16. Highly accurate fluorogenic DNA sequencing with information theory-based error correction.

    Science.gov (United States)

    Chen, Zitian; Zhou, Wenxiong; Qiao, Shuo; Kang, Li; Duan, Haifeng; Xie, X Sunney; Huang, Yanyi

    2017-12-01

    Eliminating errors in next-generation DNA sequencing has proved challenging. Here we present error-correction code (ECC) sequencing, a method to greatly improve sequencing accuracy by combining fluorogenic sequencing-by-synthesis (SBS) with an information theory-based error-correction algorithm. ECC embeds redundancy in sequencing reads by creating three orthogonal degenerate sequences, generated by alternate dual-base reactions. This is similar to encoding and decoding strategies that have proved effective in detecting and correcting errors in information communication and storage. We show that, when combined with a fluorogenic SBS chemistry with raw accuracy of 98.1%, ECC sequencing provides single-end, error-free sequences up to 200 bp. ECC approaches should enable accurate identification of extremely rare genomic variations in various applications in biology and medicine.

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

  18. An empirical assessment of the short-term impacts of a reading of Deborah Zoe Laufer's drama Informed Consent on attitudes and intentions to participate in genetic research.

    Science.gov (United States)

    Rothwell, Erin; Botkin, Jeffrey R; Cheek-O'Donnell, Sydney; Wong, Bob; Case, Gretchen A; Johnson, Erin; Matheson, Trent; Wilson, Alena; Robinson, Nicole R; Rawlings, Jared; Horejsi, Brooke; Lopez, Ana Maria; Byington, Carrie L

    2018-01-01

    This study assessed the short-term impact of the play "Informed Consent" by Deborah Zoe Laufer (a fictionalized look at the controversy over specimens collected from the Havasupai Tribe for diabetes research in 1989) on perceptions of trust, willingness to donate biospecimens, and attitudes toward harm and privacy among the medical and undergraduate students, faculty, and the public in the Intermountain West. Surveys were administered before and after a staged reading of the play by professional actors. Survey items included the short form Trust in Medical Researchers, and single-item questions about group identity, ethics of genetic testing in children, and willingness to donate biospecimens. In addition, respondents were given the option to answer open-ended questions through e-mail. Out of the 481 who attended the play, 421 completed both the pre and post surveys, and 166 participants completed open-ended questions online approximately 1 week after the play. Across all participants, there were significant declines for trust in medical researchers and for the survey item "is it ethical for investigators to test children for adult onset diseases" (p < .001 for both) following the play. There was a significant increase in agreement to improve group identity protections (p < .001) and there were no differences on willingness to donate biospecimens to research (p = .777). Qualitative data provided extensive contextual data supporting these perspectives. This is one of the first studies to document short-term impacts of a theatrical performance on both attitudes and behavioral intentions toward research ethics and clinical research participation. Future research should continue to explore the impact of theatrical performances among public and investigators on the ethical issues and complexities in clinical research.

  19. Short- versus long-term radon detectors: a comparative study in Galicia, NW Spain

    International Nuclear Information System (INIS)

    Ruano-Ravina, A.; Castro-Bernardez, M.; Sande-Meijide, M.; Vargas, A.; Barros-Dios, J.M.

    2008-01-01

    As reported in previous studies, Galicia (NW Spain) is an area of high radon concentrations. This study was sought to analyze the correlation between short-term (activated carbon) and long-term (alpha particle track) detectors in this geographic area, and ascertain whether there were differences in their readings that might be influenced by other variables. A comparison study, as part of a case-control study was designed in which two detectors, one of each type, were placed in the selected homes. A total of 391 homes yielded readings with both detectors. The results indicated that there was a relatively good correlation between both types of monitors (correlation coefficient 0.608; p < 0.001). The highest correlations between both detectors were observed for unventilated homes, coastal sites, and the oldest buildings. Short-term and long-term detectors do not show a similar performance in all settings or situations. It is advisable to use long-term detectors whenever possible

  20. Short- versus long-term radon detectors: a comparative study in Galicia, NW Spain

    Energy Technology Data Exchange (ETDEWEB)

    Ruano-Ravina, A. [Department of Preventive Medicine and Public Health, School of Medicine, University of Santiago de Compostela, C/San Francisco s/n, 15782 Santiago de Compostela (Spain); Galician Agency for Health Technology Assessment, Galician Health Service, Santiago de Compostela (Spain); CIBER de Epidemiologia y Salud Publica, CIBERESP (Spain)], E-mail: mralbert@usc.es; Castro-Bernardez, M. [Epidemiology Department, Directorate-General for Public Health, Galician Regional Authority (Spain); Sande-Meijide, M. [Preventive Medicine Unit, Ourense Hospital Complex, Galician Health Service (Spain); Vargas, A. [Energy Techniques Institute, Polytechnic University of Catalonia, Barcelona (Spain); Barros-Dios, J.M. [Department of Preventive Medicine and Public Health, School of Medicine, University of Santiago de Compostela, C/San Francisco s/n, 15782 Santiago de Compostela (Spain); CIBER de Epidemiologia y Salud Publica, CIBERESP (Spain); Preventive Medicine Unit, Santiago de Compostela University Hospital, Galician Health Service (Spain)

    2008-07-15

    As reported in previous studies, Galicia (NW Spain) is an area of high radon concentrations. This study was sought to analyze the correlation between short-term (activated carbon) and long-term (alpha particle track) detectors in this geographic area, and ascertain whether there were differences in their readings that might be influenced by other variables. A comparison study, as part of a case-control study was designed in which two detectors, one of each type, were placed in the selected homes. A total of 391 homes yielded readings with both detectors. The results indicated that there was a relatively good correlation between both types of monitors (correlation coefficient 0.608; p < 0.001). The highest correlations between both detectors were observed for unventilated homes, coastal sites, and the oldest buildings. Short-term and long-term detectors do not show a similar performance in all settings or situations. It is advisable to use long-term detectors whenever possible.

  1. The Effect of Background Music While Silent Reading on EFL Learners’ Reading Comprehension

    Directory of Open Access Journals (Sweden)

    sakineh sahebdel

    2014-05-01

    Full Text Available This study attempted to determine the effect of background music while silent reading on Iranian EFL learners’ reading comprehension. The participants were 57 Iranian EFL learners between the ages of 14 and 16 in two 3rd grade high schoolclasses at pre-intermediate proficiency level. Before treatment,both experimental and control groups took a reading comprehension pretest. In the experimental group, the researchers played Mozart sonatas as background music and asked them to read the passage silently and then answer the reading comprehension questions. In the control group, the procedure was the same, but no music was played while silent reading by the students. After ten sessions, the students of both groups were asked to answer another independent but parallel form of reading section of PET as their post-test. The independent samples t-testresultsindicated that the experimental group outperformed the control group in reading comprehension posttest, and listening to background music while silent reading had a significantly positive effect on Iranian EFL learners’ reading comprehension. The results of the present study have implications for EFL students, teachers, and teacher educators as well as syllabus designers and materials developers.

  2. Reading Journal as A Way to Improve Students’ Comprehension toward A Textbook Reading Material

    Directory of Open Access Journals (Sweden)

    Menik Winiharti

    2014-11-01

    Full Text Available Reading journal is one way to record students’ independent learning based on text they read. This study was conducted to find out the students’ level of reading comprehension through some notes written in the reading journal, the extent to which the activity of writing reading journals improved students’ reading comprehension, whether the students got benefit from reading journal. There were 104 respondents coming from four different departments in Bina Nusantara University were asked to read a text related to the subject they learned in a certain session. Then they were assigned to write a journal that records the things they had read. When this task was finished, the lecturer ran a quiz containing related questions to check whether they really understood the content of the text. Afterwards, students were to fill in a questionnaire regarding their opinion on the impact of the reading journal toward their reading comprehension. The findings indicate that more than half of the participants appear to understand the material well, and the task plays a certain role in improving students’ understanding. The most crucial thing is that most students think they get benefit by writing the reading journal.

  3. SchemaOnRead Manual

    Energy Technology Data Exchange (ETDEWEB)

    North, Michael J. [Argonne National Lab. (ANL), Argonne, IL (United States)

    2015-09-30

    SchemaOnRead provides tools for implementing schema-on-read including a single function call (e.g., schemaOnRead("filename")) that reads text (TXT), comma separated value (CSV), raster image (BMP, PNG, GIF, TIFF, and JPG), R data (RDS), HDF5, NetCDF, spreadsheet (XLS, XLSX, ODS, and DIF), Weka Attribute-Relation File Format (ARFF), Epi Info (REC), Pajek network (PAJ), R network (NET), Hypertext Markup Language (HTML), SPSS (SAV), Systat (SYS), and Stata (DTA) files. It also recursively reads folders (e.g., schemaOnRead("folder")), returning a nested list of the contained elements.

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

  5. Experiments of Multi-Level Read-Only Recording Using Readout Signal Wave-Shape Modulation

    International Nuclear Information System (INIS)

    Yi, Tang; Jing, Pei; Long-Fa, Pan; Yi, Ni; Hua, Hu; Bu-Qing, Zhang

    2008-01-01

    An innovative multilevel read-only recording method is proposed. In this method, a short pit/land is deliberately inserted to the original land/pit. This modifies the wave-shape of readout signal. Taking the wave-shape as the symbol of level detection, a signal wave-shape modulation (SWSM) multilevel method is realized. This method is carried out and validated on the DVD read-only manufacture and readout system. A capacity of 15 GB can be expected, and a bit error rate of 10 −4 is achieved. The capacity can meet the demand of high definition movie publication. This method also provides a potential multi-level solution for other storage formats and systems. (fundamental areas of phenomenology (including applications))

  6. 501 reading comprehension questions

    CERN Document Server

    2014-01-01

    This updated edition offers the most extensive and varied practice for all types of questions students might face on standardized and in-class tests. With this guide, students will learn to develop expert reading strategies, understand how to read faster and with greater comprehension, overcome reading anxiety, and increase appreciation of reading for pleasure. This book's step-by-step approach provides graduated coverage that moves from the basics to more advanced reading.

  7. Psychometric Research in Reading.

    Science.gov (United States)

    Davis, Frederick B.

    This review of psychometric research in reading analyzes the factors which seem related to reading comprehension skills. Experimental analysis of reading comprehension by L. E. Thorndike revealed two major components: knowledge of word meanings and verbal reasoning abilities. Subsequent analysis of experimental studies of reading comprehension…

  8. Critical reading and critical thinking Critical reading and critical thinking

    Directory of Open Access Journals (Sweden)

    Loni Kreis Taglieber

    2008-04-01

    Full Text Available The purpose of this paper is to provide, for L1 and L2 reading and writing teachers, a brief overview of the literature about critical reading and higher level thinking skills. The teaching of these skills is still neglected in some language classes in Brazil, be it in L1 or in L2 classes. Thus, this paper may also serve as a resource guide for L1 and/or L2 reading and writing teachers who want to incorporate critical reading and thinking into their classes. In modern society, even in everyday life people frequently need to deal with complicated public and political issues, make decisions, and solve problems. In order to do this efficiently and effectively, citizens must be able to evaluate critically what they see, hear, and read. Also, with the huge amount of printed material available in all areas in this age of “information explosion” it is easy to feel overwhelmed. But often the information piled up on people’s desks and in their minds is of no use due to the enormous amount of it. The purpose of this paper is to provide, for L1 and L2 reading and writing teachers, a brief overview of the literature about critical reading and higher level thinking skills. The teaching of these skills is still neglected in some language classes in Brazil, be it in L1 or in L2 classes. Thus, this paper may also serve as a resource guide for L1 and/or L2 reading and writing teachers who want to incorporate critical reading and thinking into their classes. In modern society, even in everyday life people frequently need to deal with complicated public and political issues, make decisions, and solve problems. In order to do this efficiently and effectively, citizens must be able to evaluate critically what they see, hear, and read. Also, with the huge amount of printed material available in all areas in this age of “information explosion” it is easy to feel overwhelmed. But often the information piled up on people’s desks and in their minds is of

  9. Reading and Empathy

    Science.gov (United States)

    McCreary, John J.; Marchant, Gregory J.

    2017-01-01

    The relationship between reading and empathy was explored. Controlling for GPA and gender, reading variables were hypothesized as related to empathy; the relationship was expected to differ for males and females. For the complete sample, affective components were related to GPA but not reading. Perspective taking was related to reading…

  10. Reading Big Words: Instructional Practices to Promote Multisyllabic Word Reading Fluency

    Science.gov (United States)

    Toste, Jessica R.; Williams, Kelly J.; Capin, Philip

    2017-01-01

    Poorly developed word recognition skills are the most pervasive and debilitating source of reading challenges for students with learning disabilities (LD). With a notable decrease in word reading instruction in the upper elementary grades, struggling readers receive fewer instructional opportunities to develop proficient word reading skills, yet…

  11. Theme: Parents and Reading.

    Science.gov (United States)

    Jund, Suzanne, Ed.

    1977-01-01

    This journal issue concentrates on the theme "Parents and Reading." It presents articles on sharing books with young children, using public relations in a reading program, guiding preschool learning, assessing language readiness, working with reading problems, and teaching reading readiness in Wisconsin kindergartens. Resources and a review of…

  12. Effects of reading goals on reading comprehension, reading rate, and allocation of working memory in children and adolescents with spina bifida meningomyelocele

    Science.gov (United States)

    ENGLISH, LIANNE; BARNES, MARCIA A.; FLETCHER, JACK M.; DENNIS, MAUREEN; RAGHUBAR, KIMBERLY P.

    2011-01-01

    Spina bifida meningomyelocele (SBM) is a neurodevelopmental disorder associated with intact word decoding and deficient text and discourse comprehension. This study investigated the ability to adjust reading in accordance with specified reading goals in 79 children and adolescents with SBM (9–19 years of age) and 39 controls (8–17 years of age). Both groups demonstrated slower reading times and enhanced comprehension when reading to study or to come up with a title than when reading for specific information or for entertainment. For both groups, verbal working memory contributed to comprehension performance in those reading conditions hypothesized to require more cognitive effort. Despite their sensitivity to the goals of reading, the group with SBM answered fewer comprehension questions correctly across all reading goal conditions. The results are discussed in relation to the hypothesized cognitive underpinnings of comprehension deficits in SBM and to current models of text comprehension. PMID:20338082

  13. Effects of reading goals on reading comprehension, reading rate, and allocation of working memory in children and adolescents with spina bifida meningomyelocele.

    Science.gov (United States)

    English, Lianne; Barnes, Marcia A; Fletcher, Jack M; Dennis, Maureen; Raghubar, Kimberly P

    2010-05-01

    Spina bifida meningomyelocele (SBM) is a neurodevelopmental disorder associated with intact word decoding and deficient text and discourse comprehension. This study investigated the ability to adjust reading in accordance with specified reading goals in 79 children and adolescents with SBM (9-19 years of age) and 39 controls (8-17 years of age). Both groups demonstrated slower reading times and enhanced comprehension when reading to study or to come up with a title than when reading for specific information or for entertainment. For both groups, verbal working memory contributed to comprehension performance in those reading conditions hypothesized to require more cognitive effort. Despite their sensitivity to the goals of reading, the group with SBM answered fewer comprehension questions correctly across all reading goal conditions. The results are discussed in relation to the hypothesized cognitive underpinnings of comprehension deficits in SBM and to current models of text comprehension.

  14. Reading disorders and dyslexia.

    Science.gov (United States)

    Hulme, Charles; Snowling, Margaret J

    2016-12-01

    We review current knowledge about the nature of reading development and disorders, distinguishing between the processes involved in learning to decode print, and the processes involved in reading comprehension. Children with decoding difficulties/dyslexia experience deficits in phoneme awareness, letter-sound knowledge and rapid automatized naming in the preschool years and beyond. These phonological/language difficulties appear to be proximal causes of the problems in learning to decode print in dyslexia. We review data from a prospective study of children at high risk of dyslexia to show that being at family risk of dyslexia is a primary risk factor for poor reading and children with persistent language difficulties at school entry are more likely to develop reading problems. Early oral language difficulties are strong predictors of later difficulties in reading comprehension. There are two distinct forms of reading disorder in children: dyslexia (a difficulty in learning to translate print into speech) and reading comprehension impairment. Both forms of reading problem appear to be predominantly caused by deficits in underlying oral language skills. Implications for screening and for the delivery of robust interventions for language and reading are discussed.

  15. Testing a Nested Skills Model of the Relations among Invented Spelling, Accurate Spelling, and Word Reading, from Kindergarten to Grade 1

    Science.gov (United States)

    Sénéchal, Monique

    2017-01-01

    The goal was to assess the role of invented spelling to subsequent reading and spelling as proposed by the Nested Skills Model of Early Literacy Acquisition. 107 English-speaking children were tested at the beginning of kindergarten and grade 1, and at the end of grade 1. The findings provided support for the proposed model. First, the role played…

  16. Systematic shifts of evaluated charge centroid for the cathode read-out multiwire proportional chamber

    International Nuclear Information System (INIS)

    Endo, I.; Kawamoto, T.; Mizuno, Y.; Ohsugi, T.; Taniguchi, T.; Takeshita, T.

    1981-01-01

    We have investigated the systematic error associtated with the charge centroid evaluation for the cathode read-out multiwire proportional chamber. Correction curves for the systematic error according to six centroid finding algorithms have been obtained by using the charge distribution calculated in a simple electrostatic mode. They have been experimentally examined and proved to be essential for the accurate determination of the irradiated position. (orig.)

  17. CLIP-seq analysis of multi-mapped reads discovers novel functional RNA regulatory sites in the human transcriptome.

    Science.gov (United States)

    Zhang, Zijun; Xing, Yi

    2017-09-19

    Crosslinking or RNA immunoprecipitation followed by sequencing (CLIP-seq or RIP-seq) allows transcriptome-wide discovery of RNA regulatory sites. As CLIP-seq/RIP-seq reads are short, existing computational tools focus on uniquely mapped reads, while reads mapped to multiple loci are discarded. We present CLAM (CLIP-seq Analysis of Multi-mapped reads). CLAM uses an expectation-maximization algorithm to assign multi-mapped reads and calls peaks combining uniquely and multi-mapped reads. To demonstrate the utility of CLAM, we applied it to a wide range of public CLIP-seq/RIP-seq datasets involving numerous splicing factors, microRNAs and m6A RNA methylation. CLAM recovered a large number of novel RNA regulatory sites inaccessible by uniquely mapped reads. The functional significance of these sites was demonstrated by consensus motif patterns and association with alternative splicing (splicing factors), transcript abundance (AGO2) and mRNA half-life (m6A). CLAM provides a useful tool to discover novel protein-RNA interactions and RNA modification sites from CLIP-seq and RIP-seq data, and reveals the significant contribution of repetitive elements to the RNA regulatory landscape of the human transcriptome. © The Author(s) 2017. Published by Oxford University Press on behalf of Nucleic Acids Research.

  18. Intrinsic and Extrinsic Reading Motivation as Predictors of Reading Literacy: A Longitudinal Study

    Science.gov (United States)

    Becker, Michael; McElvany, Nele; Kortenbruck, Marthe

    2010-01-01

    The purpose in this study was to examine the longitudinal relationships of intrinsic and extrinsic motivation with reading literacy development. In particular, the authors (a) investigated reading amount as mediator between motivation and reading literacy and (b) probed for bidirectional relationships between reading motivation and reading…

  19. Predictors of Foreign Language Reading Comprehension in a Hypermedia Reading Environment

    Science.gov (United States)

    Akbulut, Yavuz

    2008-01-01

    This study investigated factors affecting second/foreign language (L2) reading comprehension in a hypermedia environment within the theoretical framework of dual coding and cognitive load theories, and interactive models of L2 reading. The independent variables were reading ability, topic interest, prior topical knowledge, and the number of times…

  20. Tracking the reading eye: towards a model of real-world reading

    NARCIS (Netherlands)

    Jarodzka, Halszka; Brand-Gruwel, Saskia

    2018-01-01

    Eye tracking has helped to understand the process of reading a word or a sentence, and this research has been very fruitful over the past decades. However, everyday real-world reading dramatically differs from this scenario: we read a newspaper on the bus, surf the Internet for movie reviews or

  1. Parents Using Explicit Reading Instruction with Their Children At-Risk for Reading Difficulties

    Science.gov (United States)

    McConnell, Bethany M.; Kubina, Rick

    2016-01-01

    Kindergarten students at-risk for reading difficulties were selected for participation in a parent implemented reading program. Each parent provided instruction to his or her child using the reading program "Teach Your Child to Read in 100 Easy Lessons" ("TYCTR"; Engelmann, Haddox, & Bruner, 1983). Parents were expected to…

  2. Numerical study of read scheme in one-selector one-resistor crossbar array

    Science.gov (United States)

    Kim, Sungho; Kim, Hee-Dong; Choi, Sung-Jin

    2015-12-01

    A comprehensive numerical circuit analysis of read schemes of a one selector-one resistance change memory (1S1R) crossbar array is carried out. Three schemes-the ground, V/2, and V/3 schemes-are compared with each other in terms of sensing margin and power consumption. Without the aid of a complex analytical approach or SPICE-based simulation, a simple numerical iteration method is developed to simulate entire current flows and node voltages within a crossbar array. Understanding such phenomena is essential in successfully evaluating the electrical specifications of selectors for suppressing intrinsic drawbacks of crossbar arrays, such as sneaky current paths and series line resistance problems. This method provides a quantitative tool for the accurate analysis of crossbar arrays and provides guidelines for developing an optimal read scheme, array configuration, and selector device specifications.

  3. Oral Reading Fluency as a Predictor of Silent Reading Fluency at Secondary and Postsecondary Levels

    Science.gov (United States)

    Seok, Soonhwa; DaCosta, Boaventura

    2014-01-01

    This research investigated oral reading fluency as a predictor of silent reading fluency at the secondary and postsecondary levels. Several measures were used, including the Gray Oral Reading Test, the Test of Silent Word Reading Fluency, the Test of Silent Contextual Reading Fluency, and the Reading Observation Scale. A total of 223 students…

  4. Investigating Chinese English Majors’ Use of Reading Strategies : A Study on the Relationship between Reading Strategies and Reading Achievements 

    OpenAIRE

    Sun, Ling

    2011-01-01

    For several decades, reading strategies have aroused many researchers’ interest.Readingis a very important language skill for English learners; however, many English majors feel that their reading proficiency is far from satisfying though they have studied English for more than ten years. Therefore, the current situation of using reading strategies among Chinese sophomore English majors is studied in this paper. The research aims to study the relationship between the use of reading strategies...

  5. An Accurate Link Correlation Estimator for Improving Wireless Protocol Performance

    Science.gov (United States)

    Zhao, Zhiwei; Xu, Xianghua; Dong, Wei; Bu, Jiajun

    2015-01-01

    Wireless link correlation has shown significant impact on the performance of various sensor network protocols. Many works have been devoted to exploiting link correlation for protocol improvements. However, the effectiveness of these designs heavily relies on the accuracy of link correlation measurement. In this paper, we investigate state-of-the-art link correlation measurement and analyze the limitations of existing works. We then propose a novel lightweight and accurate link correlation estimation (LACE) approach based on the reasoning of link correlation formation. LACE combines both long-term and short-term link behaviors for link correlation estimation. We implement LACE as a stand-alone interface in TinyOS and incorporate it into both routing and flooding protocols. Simulation and testbed results show that LACE: (1) achieves more accurate and lightweight link correlation measurements than the state-of-the-art work; and (2) greatly improves the performance of protocols exploiting link correlation. PMID:25686314

  6. Who Says They Don’t Read? Slovene Elementary School Students’ Reading Motivation in EFL

    Directory of Open Access Journals (Sweden)

    Anja Pirih

    2015-05-01

    Full Text Available A typical (Slovene teenager today no longer finds reading materials on the book shelves in the local library, but forms a reading list of electronic sources, very often in English. However, in contrast with an abundance of studies focusing on first language (L1 reading strategies and motivation, not a lot of literature can be found on reading motivation in a foreign language, even though it is perceived as one of the most important factors influencing second language (L2 development. The aim of this research is to determine the influences on reading motivation in English as a foreign language in the group of young teenagers (11-14-year-olds and a possible transfer of L1 reading attitudes to L2 reading. The theoretical framework relies on Wigfield and Guthrie’s (1997 self-efficacy theory and Day and Bamford’s (1998 expectancy value model. The data obtained from 197 questionnaires give an insight into not only the frequency of reading in English and the type of reading materials, but also the factors influencing teenagers’ reading motivation in EFL.

  7. INTEREST AND READING MOTIVATION

    Directory of Open Access Journals (Sweden)

    Alhamdu Alhamdu

    2016-05-01

    Full Text Available The purpose of this study is to examine the relationship between interest and reading motivation based on literature review. The concept of the interest portrayed as a psychological state that occurs during interaction between individual and specific topic, object or activity including process of willingness, increased attention, concentration and positive feeling to the topic, object or activity. Meanwhile reading motivation emphasized to mental readiness, willingness and refers to beliefs and perception of individual to engage in reading activity. Some researchers were identified factors that influenced reading motivation such as intrinsic and extrinsic factors, self-concept and value of reading, and interest. In general, the literature review described that have positive relationship between interest and reading motivation.

  8. Using Reading Guides and On-Line Quizzes to Improve Reading Compliance and Quiz Scores

    Science.gov (United States)

    Maurer, Trent W.; Longfield, Judith

    2015-01-01

    This study compared students' daily in-class reading quiz scores in an introductory Child Development course across five conditions: control, reading guide only, reading guide and on-line practice quiz, reading guide and on-line graded quiz, and reading guide and both types of on-line quizzes. At the beginning of class, students completed a 5-item…

  9. The contribution of phonological knowledge, memory, and language background to reading comprehension in deaf populations

    Directory of Open Access Journals (Sweden)

    Elizabeth Ann Hirshorn

    2015-08-01

    Full Text Available While reading is challenging for many deaf individuals, some become proficient readers. Yet we do not know the component processes that support reading comprehension in these individuals. Speech-based phonological knowledge is one of the strongest predictors of reading comprehension in hearing individuals, yet its role in deaf readers is controversial. This could reflect the highly varied language backgrounds among deaf readers as well as the difficulty of disentangling the relative contribution of phonological versus orthographic knowledge of spoken language, in our case ‘English’, in this population. Here we assessed the impact of language experience on reading comprehension in deaf readers by recruiting oral deaf individuals, who use spoken English as their primary mode of communication, and deaf native signers of American Sign Language. First, to address the contribution of spoken English phonological knowledge in deaf readers, we present novel tasks that evaluate phonological versus orthographic knowledge. Second, the impact of this knowledge, as well as verbal short-term memory and long-term memory skills, on reading comprehension was evaluated. The best predictor of reading comprehension differed as a function of language experience, with long-term memory, as measured by free recall, being a better predictor in deaf native signers than in oral deaf. In contrast, the measures of English phonological knowledge, independent of orthographic knowledge, best predicted reading comprehension in oral deaf individuals. These results suggest successful reading strategies differ across deaf readers as a function of their language experience, and highlight a possible alternative route to literacy in deaf native signers.

  10. Effects of sequential and discrete rapid naming on reading in Japanese children with reading difficulty.

    Science.gov (United States)

    Wakamiya, Eiji; Okumura, Tomohito; Nakanishi, Makoto; Takeshita, Takashi; Mizuta, Mekumi; Kurimoto, Naoko; Tamai, Hiroshi

    2011-06-01

    To clarify whether rapid naming ability itself is a main underpinning factor of rapid automatized naming tests (RAN) and how deep an influence the discrete decoding process has on reading, we performed discrete naming tasks and discrete hiragana reading tasks as well as sequential naming tasks and sequential hiragana reading tasks with 38 Japanese schoolchildren with reading difficulty. There were high correlations between both discrete and sequential hiragana reading and sentence reading, suggesting that some mechanism which automatizes hiragana reading makes sentence reading fluent. In object and color tasks, there were moderate correlations between sentence reading and sequential naming, and between sequential naming and discrete naming. But no correlation was found between reading tasks and discrete naming tasks. The influence of rapid naming ability of objects and colors upon reading seemed relatively small, and multi-item processing may work in relation to these. In contrast, in the digit naming task there was moderate correlation between sentence reading and discrete naming, while no correlation was seen between sequential naming and discrete naming. There was moderate correlation between reading tasks and sequential digit naming tasks. Digit rapid naming ability has more direct effect on reading while its effect on RAN is relatively limited. The ratio of how rapid naming ability influences RAN and reading seems to vary according to kind of the stimuli used. An assumption about components in RAN which influence reading is discussed in the context of both sequential processing and discrete naming speed. Copyright © 2010 The Japanese Society of Child Neurology. Published by Elsevier B.V. All rights reserved.

  11. The Reading Habits of Developmental College Students at Different Levels of Reading Proficiency.

    Science.gov (United States)

    Sheorey, Ravi; Mokhtari, Kouider

    1994-01-01

    Examines differences in reading habits of developmental college students with varying levels of reading proficiency. Finds that subjects spent an unusually low amount of time on academic reading and even less time on nonacademic reading. Finds no significant differences between high- and low-proficient readers with regard to amount of time spent…

  12. Reading for Pleasure in Paradise: Paired Reading in Antigua and Barbuda

    Science.gov (United States)

    Warrington, Molly J.; George, Patricia

    2014-01-01

    Reading for pleasure is essential in the development of literacy. This paper reports on findings from a paired reading strategy introduced into primary schools in Antigua and Barbuda in order to foster children's pleasure in reading. This programme of cross-age peer tutoring intervention began with the training of teachers in a small group of…

  13. A Case for Improved Reading Instruction for Academic English Reading Proficiency

    Directory of Open Access Journals (Sweden)

    Glenn Ole Hellekjær

    2008-06-01

    Full Text Available This article presents a study of the academic reading proficiency in English of 217 senior level Norwegian upper secondary school students who upon graduation are considered qualified for higher education. Testing with an International English Language Testing System (IELTS Academic Reading Module revealed that two thirds of the 178 respondents with ordinary EFL courses did not achieve the equivalent of the IELTS Band 6 score minimum that is usually required for admission to British and Australian universities. In comparison, two thirds of a sample of 39 respondents with a single, sheltered Content and Language Integrated Learning (CLIL subject achieved a Band 6 score or better. Closer analysis indicates that the poor test scores can be attributed to weaknesses in current English as a Foreign Language (EFL instruction where reading is neglected, where students do not learn to adjust how they read to reading purpose, and where they do not learn how to handle unfamiliar words to avoid disrupting the reading process. The article ends with suggestions on how to improve EFL instruction, in Norway and elsewhere.

  14. Reading use in preschool

    OpenAIRE

    Laísa Cristina dos Santos Guilherme; Rodrigo Ferreira Daverni

    2016-01-01

    Abstract: Reading in preschool is a time of awakening the taste and pleasure in reading, it is also a source of reflection, discovery and learn to listen. It is then necessary that the contact with the reading start from pre-school, with a variety of texts and the teacher also has the habit of reading in their daily lives. Therefore, this study aimed to investigate the benefits of daily reading in the classroom pre-school life of a student, which the characteristics of a player and teacher re...

  15. The Role of Reading Skills on Reading Comprehension Ability of Turkish EFL Students

    Directory of Open Access Journals (Sweden)

    Ebru Kaya

    2015-12-01

    Full Text Available Reading is a part of our daily lives. It is performed both for pleasure and information. Reading skills are important for the individuals since they foster comprehension in reading. If the students do not have knowledge of reading skills, they cannot be expected to be successful readers. Thus, they cannot achieve the level of comprehension required to pass exams in their own departments. For this reason, reading skills should be taught in universities for the students to be able to cope with comprehension problems. This case study aims to find out whether or not reading skills has a role on the reading comprehension ability of Turkish EFL students. This study is both a qualitative and a quantitative study which lasted for a duration of 14 weeks. Two groups were selected (experimental and control among prep classes at Kahramanmaraş Sütçü Imam University. Both groups were administered a pre-test and questionnaire at the beginning of the study to find out if they were aware of reading skills. In addition, 10 students were chosen randomly for interview. During the study, reading skills were infused into the curriculum through designing lesson plans in accordance with the language content and topics for level C students, as determined by the Common European Language Framework. The lessons required the students to use reading skills before, during, and post reading. At the end of the study, the same questionnaire was re-administered. The students were given the post-test and then interviewed. The quantitative data were analyzed through descriptive statistics. The obtained data revealed that the students enhanced their comprehension ability provided that they were taught to use reading skills.

  16. The Influence of Translation on Reading Amount, Proficiency, and Speed in Extensive Reading

    Science.gov (United States)

    Sakurai, Nobuko

    2015-01-01

    This study attempted to examine the influence of a decrease in translation on the number of words read, reading comprehension, and reading rate in an extensive reading (ER) program. The participants were 70 first-year university students who experienced ER both in and outside the classroom for 15 weeks. The results of regression analyses confirmed…

  17. THE USE OF SCHEMATA IN READING COMPREHENSION: A CASE OF LEARNERS’ READING PROBLEMS

    Directory of Open Access Journals (Sweden)

    Cucu Sutarsyah

    2016-02-01

    Full Text Available The Use of Schemata in Reading Comprehension: A Case of Learners’ Reading Problems. Schemata have an important role in the process of reading. It is almost impossible for a person to read without utilizing schemata. This study aimed to find learners’ reading problem in terms of using sche­mata.  A group of second year students of English Department of State University of Malang were in­volved in this study. As a case study, an interview, observation, and test were used to collect the data. The study reveals that the main reading problems were lack of background knowledge, over-reliance on background knowledge, and lack of background knowledge activation. In the process of reading, learn­ers’ background knowledge should be activated. Without optimal activation, the process of reading does not reach satisfactory results. It is also suggested that learners should not be over confident in get­ting the meaning from the text. Over-reliance on background knowledge might lead to misinterpretation.

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

  19. Reimagining Reading: Creating a Classroom Culture That Embraces Independent Choice Reading

    Science.gov (United States)

    Dickerson, Katie

    2015-01-01

    Many of us are plagued by negative memories of sustained silent reading. In some of these memories, we are the students, attempting to read a book that didn't hold our interest or trying to read over the din of our disengaged classmates. In other memories, we are the teachers, suffering through a ten-minute classroom management nightmare, deciding…

  20. Fostering the Love of Reading: The Affective Domain in Reading Education.

    Science.gov (United States)

    Cramer, Eugene H., Ed.; Castle, Marrietta, Ed.

    Representing current thinking about a wide range of issues related to reading motivation, this book offers a look at how to create classroom cultures that foster in students the love of reading. The book is about teachers and the critical role they play in helping children develop into motivated, active, engaged readers who read both for pleasure…