WorldWideScience

Sample records for alignment improves dna

  1. CSA: An efficient algorithm to improve circular DNA multiple alignment

    Directory of Open Access Journals (Sweden)

    Pereira Luísa

    2009-07-01

    Full Text Available Abstract Background The comparison of homologous sequences from different species is an essential approach to reconstruct the evolutionary history of species and of the genes they harbour in their genomes. Several complete mitochondrial and nuclear genomes are now available, increasing the importance of using multiple sequence alignment algorithms in comparative genomics. MtDNA has long been used in phylogenetic analysis and errors in the alignments can lead to errors in the interpretation of evolutionary information. Although a large number of multiple sequence alignment algorithms have been proposed to date, they all deal with linear DNA and cannot handle directly circular DNA. Researchers interested in aligning circular DNA sequences must first rotate them to the "right" place using an essentially manual process, before they can use multiple sequence alignment tools. Results In this paper we propose an efficient algorithm that identifies the most interesting region to cut circular genomes in order to improve phylogenetic analysis when using standard multiple sequence alignment algorithms. This algorithm identifies the largest chain of non-repeated longest subsequences common to a set of circular mitochondrial DNA sequences. All the sequences are then rotated and made linear for multiple alignment purposes. To evaluate the effectiveness of this new tool, three different sets of mitochondrial DNA sequences were considered. Other tests considering randomly rotated sequences were also performed. The software package Arlequin was used to evaluate the standard genetic measures of the alignments obtained with and without the use of the CSA algorithm with two well known multiple alignment algorithms, the CLUSTALW and the MAVID tools, and also the visualization tool SinicView. Conclusion The results show that a circularization and rotation pre-processing step significantly improves the efficiency of public available multiple sequence alignment

  2. Efficient alignment-free DNA barcode analytics.

    Science.gov (United States)

    Kuksa, Pavel; Pavlovic, Vladimir

    2009-11-10

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

  3. RevTrans: multiple alignment of coding DNA from aligned amino acid sequences

    DEFF Research Database (Denmark)

    Wernersson, Rasmus; Pedersen, Anders Gorm

    2003-01-01

    The simple fact that proteins are built from 20 amino acids while DNA only contains four different bases, means that the 'signal-to-noise ratio' in protein sequence alignments is much better than in alignments of DNA. Besides this information-theoretical advantage, protein alignments also benefit...... proteins. It is therefore preferable to align coding DNA at the amino acid level and it is for this purpose we have constructed the program RevTrans. RevTrans constructs a multiple DNA alignment by: (i) translating the DNA; (ii) aligning the resulting peptide sequences; and (iii) building a multiple DNA...

  4. DNAAlignEditor: DNA alignment editor tool

    Directory of Open Access Journals (Sweden)

    Guill Katherine E

    2008-03-01

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

  5. Application of Quaternion in improving the quality of global sequence alignment scores for an ambiguous sequence target in Streptococcus pneumoniae DNA

    Science.gov (United States)

    Lestari, D.; Bustamam, A.; Novianti, T.; Ardaneswari, G.

    2017-07-01

    DNA sequence can be defined as a succession of letters, representing the order of nucleotides within DNA, using a permutation of four DNA base codes including adenine (A), guanine (G), cytosine (C), and thymine (T). The precise code of the sequences is determined using DNA sequencing methods and technologies, which have been developed since the 1970s and currently become highly developed, advanced and highly throughput sequencing technologies. So far, DNA sequencing has greatly accelerated biological and medical research and discovery. However, in some cases DNA sequencing could produce any ambiguous and not clear enough sequencing results that make them quite difficult to be determined whether these codes are A, T, G, or C. To solve these problems, in this study we can introduce other representation of DNA codes namely Quaternion Q = (PA, PT, PG, PC), where PA, PT, PG, PC are the probability of A, T, G, C bases that could appear in Q and PA + PT + PG + PC = 1. Furthermore, using Quaternion representations we are able to construct the improved scoring matrix for global sequence alignment processes, by applying a dot product method. Moreover, this scoring matrix produces better and higher quality of the match and mismatch score between two DNA base codes. In implementation, we applied the Needleman-Wunsch global sequence alignment algorithm using Octave, to analyze our target sequence which contains some ambiguous sequence data. The subject sequences are the DNA sequences of Streptococcus pneumoniae families obtained from the Genebank, meanwhile the target DNA sequence are received from our collaborator database. As the results we found the Quaternion representations improve the quality of the sequence alignment score and we can conclude that DNA sequence target has maximum similarity with Streptococcus pneumoniae.

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

    Science.gov (United States)

    Perry, William L

    2002-12-01

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

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

    Science.gov (United States)

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

    2009-07-01

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

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

    DEFF Research Database (Denmark)

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

    2009-01-01

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

  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. Spreadsheet-based program for alignment of overlapping DNA sequences.

    Science.gov (United States)

    Anbazhagan, R; Gabrielson, E

    1999-06-01

    Molecular biology laboratories frequently face the challenge of aligning small overlapping DNA sequences derived from a long DNA segment. Here, we present a short program that can be used to adapt Excel spreadsheets as a tool for aligning DNA sequences, regardless of their orientation. The program runs on any Windows or Macintosh operating system computer with Excel 97 or Excel 98. The program is available for use as an Excel file, which can be downloaded from the BioTechniques Web site. Upon execution, the program opens a specially designed customized workbook and is capable of identifying overlapping regions between two sequence fragments and displaying the sequence alignment. It also performs a number of specialized functions such as recognition of restriction enzyme cutting sites and CpG island mapping without costly specialized software.

  11. Aligned deposition and electrical measurements on single DNA molecules

    International Nuclear Information System (INIS)

    Eidelshtein, Gennady; Kotlyar, Alexander; Hashemi, Mohtadin; Gurevich, Leonid

    2015-01-01

    A reliable method of deposition of aligned individual dsDNA molecules on mica, silicon, and micro/nanofabricated circuits is presented. Complexes of biotinylated double stranded poly(dG)–poly(dC) DNA with avidin were prepared and deposited on mica and silicon surfaces in the absence of Mg 2+ ions. Due to its positive charge, the avidin attached to one end of the DNA anchors the complex to negatively charged substrates. Subsequent drying with a directional gas flow yields DNA molecules perfectly aligned on the surface. In the avidin–DNA complex only the avidin moiety is strongly and irreversibly bound to the surface, while the DNA counterpart interacts with the substrates much more weakly and can be lifted from the surface and realigned in any direction. Using this technique, avidin–DNA complexes were deposited across platinum electrodes on a silicon substrate. Electrical measurements on the deposited DNA molecules revealed linear IV-characteristics and exponential dependence on relative humidity. (paper)

  12. Alignment of Escherichia coli K12 DNA sequences to a genomic restriction map.

    Science.gov (United States)

    Rudd, K E; Miller, W; Ostell, J; Benson, D A

    1990-01-25

    We use the extensive published information describing the genome of Escherichia coli and new restriction map alignment software to align DNA sequence, genetic, and physical maps. Restriction map alignment software is used which considers restriction maps as strings analogous to DNA or protein sequences except that two values, enzyme name and DNA base address, are associated with each position on the string. The resulting alignments reveal a nearly linear relationship between the physical and genetic maps of the E. coli chromosome. Physical map comparisons with the 1976, 1980, and 1983 genetic maps demonstrate a better fit with the more recent maps. The results of these alignments are genomic kilobase coordinates, orientation and rank of the alignment that best fits the genetic data. A statistical measure based on extreme value distribution is applied to the alignments. Additional computer analyses allow us to estimate the accuracy of the published E. coli genomic restriction map, simulate rearrangements of the bacterial chromosome, and search for repetitive DNA. The procedures we used are general enough to be applicable to other genome mapping projects.

  13. Nanofabricated racks of aligned and anchored DNA substrates for single-molecule imaging.

    Science.gov (United States)

    Gorman, Jason; Fazio, Teresa; Wang, Feng; Wind, Shalom; Greene, Eric C

    2010-01-19

    Single-molecule studies of biological macromolecules can benefit from new experimental platforms that facilitate experimental design and data acquisition. Here we develop new strategies to construct curtains of DNA in which the molecules are aligned with respect to one another and maintained in an extended configuration by anchoring both ends of the DNA to the surface of a microfluidic sample chamber that is otherwise coated with an inert lipid bilayer. This "double-tethered" DNA substrate configuration is established through the use of nanofabricated rack patterns comprised of two distinct functional elements: linear barriers to lipid diffusion that align DNA molecules anchored by one end to the bilayer and antibody-coated pentagons that provide immobile anchor points for the opposite ends of the DNA. These devices enable the alignment and anchoring of thousands of individual DNA molecules, which can then be visualized using total internal reflection fluorescence microscopy under conditions that do not require continuous application of buffer flow to stretch the DNA. This unique strategy offers the potential for studying protein-DNA interactions on large DNA substrates without compromising measurements through application of hydrodynamic force. We provide a proof-of-principle demonstration that double-tethered DNA curtains made with nanofabricated rack patterns can be used in a one-dimensional diffusion assay that monitors the motion of quantum dot-tagged proteins along DNA.

  14. Micropatterning stretched and aligned DNA for sequence-specific nanolithography

    Science.gov (United States)

    Petit, Cecilia Anna Paulette

    Techniques for fabricating nanostructured materials can be categorized as either "top-down" or "bottom-up". Top-down techniques use lithography and contact printing to create patterned surfaces and microfluidic channels that can corral and organize nanoscale structures, such as molecules and nanorods in contrast; bottom-up techniques use self-assembly or molecular recognition to direct the organization of materials. A central goal in nanotechnology is the integration of bottom-up and top-down assembly strategies for materials development, device design; and process integration. With this goal in mind, we have developed strategies that will allow this integration by using DNA as a template for nanofabrication; two top-down approaches allow the placement of these templates, while the bottom-up technique uses the specific sequence of bases to pattern materials along each strand of DNA. Our first top-down approach, termed combing of molecules in microchannels (COMMIC), produces microscopic patterns of stretched and aligned molecules of DNA on surfaces. This process consists of passing an air-water interface over end adsorbed molecules inside microfabricated channels. The geometry of the microchannel directs the placement of the DNA molecules, while the geometry of the airwater interface directs the local orientation and curvature of the molecules. We developed another top-down strategy for creating micropatterns of stretched and aligned DNA using surface chemistry. Because DNA stretching occurs on hydrophobic surfaces, this technique uses photolithography to pattern vinyl-terminated silanes on glass When these surface-, are immersed in DNA solution, molecules adhere preferentially to the silanized areas. This approach has also proven useful in patterning protein for cell adhesion studies. Finally, we describe the use of these stretched and aligned molecules of DNA as templates for the subsequent bottom-up construction of hetero-structures through hybridization

  15. DIALIGN: multiple DNA and protein sequence alignment at BiBiServ.

    OpenAIRE

    Morgenstern, Burkhard

    2004-01-01

    DIALIGN is a widely used software tool for multiple DNA and protein sequence alignment. The program combines local and global alignment features and can therefore be applied to sequence data that cannot be correctly aligned by more traditional approaches. DIALIGN is available online through Bielefeld Bioinformatics Server (BiBiServ). The downloadable version of the program offers several new program features. To compare the output of different alignment programs, we developed the program AltA...

  16. Alignment of Gold Nanoparticle-Decorated DNA Origami Nanotubes: Substrate Prepatterning versus Molecular Combing.

    Science.gov (United States)

    Teschome, Bezu; Facsko, Stefan; Gothelf, Kurt V; Keller, Adrian

    2015-11-24

    DNA origami has become an established technique for designing well-defined nanostructures with any desired shape and for the controlled arrangement of functional nanostructures with few nanometer resolution. These unique features make DNA origami nanostructures promising candidates for use as scaffolds in nanoelectronics and nanophotonics device fabrication. Consequently, a number of studies have shown the precise organization of metallic nanoparticles on various DNA origami shapes. In this work, we fabricated large arrays of aligned DNA origami decorated with a high density of gold nanoparticles (AuNPs). To this end, we first demonstrate the high-yield assembly of high-density AuNP arrangements on DNA origami adsorbed to Si surfaces with few unbound background nanoparticles by carefully controlling the concentrations of MgCl2 and AuNPs in the hybridization buffer and the hybridization time. Then, we evaluate two methods, i.e., hybridization to prealigned DNA origami and molecular combing in a receding meniscus, with respect to their potential to yield large arrays of aligned AuNP-decorated DNA origami nanotubes. Because of the comparatively low MgCl2 concentration required for the efficient immobilization of the AuNPs, the prealigned DNA origami become mobile and displaced from their original positions, thereby decreasing the alignment yield. This increased mobility, on the other hand, makes the adsorbed origami susceptible to molecular combing, and a total alignment yield of 86% is obtained in this way.

  17. An Overview of DNA Microarray Grid Alignment and Foreground Separation Approaches

    Directory of Open Access Journals (Sweden)

    Bajcsy Peter

    2006-01-01

    Full Text Available This paper overviews DNA microarray grid alignment and foreground separation approaches. Microarray grid alignment and foreground separation are the basic processing steps of DNA microarray images that affect the quality of gene expression information, and hence impact our confidence in any data-derived biological conclusions. Thus, understanding microarray data processing steps becomes critical for performing optimal microarray data analysis. In the past, the grid alignment and foreground separation steps have not been covered extensively in the survey literature. We present several classifications of existing algorithms, and describe the fundamental principles of these algorithms. Challenges related to automation and reliability of processed image data are outlined at the end of this overview paper.

  18. DNA Translator and Aligner: HyperCard utilities to aid phylogenetic analysis of molecules.

    Science.gov (United States)

    Eernisse, D J

    1992-04-01

    DNA Translator and Aligner are molecular phylogenetics HyperCard stacks for Macintosh computers. They manipulate sequence data to provide graphical gene mapping, conversions, translations and manual multiple-sequence alignment editing. DNA Translator is able to convert documented GenBank or EMBL documented sequences into linearized, rescalable gene maps whose gene sequences are extractable by clicking on the corresponding map button or by selection from a scrolling list. Provided gene maps, complete with extractable sequences, consist of nine metazoan, one yeast, and one ciliate mitochondrial DNAs and three green plant chloroplast DNAs. Single or multiple sequences can be manipulated to aid in phylogenetic analysis. Sequences can be translated between nucleic acids and proteins in either direction with flexible support of alternate genetic codes and ambiguous nucleotide symbols. Multiple aligned sequence output from diverse sources can be converted to Nexus, Hennig86 or PHYLIP format for subsequent phylogenetic analysis. Input or output alignments can be examined with Aligner, a convenient accessory stack included in the DNA Translator package. Aligner is an editor for the manual alignment of up to 100 sequences that toggles between display of matched characters and normal unmatched sequences. DNA Translator also generates graphic displays of amino acid coding and codon usage frequency relative to all other, or only synonymous, codons for approximately 70 select organism-organelle combinations. Codon usage data is compatible with spreadsheet or UWGCG formats for incorporation of additional molecules of interest. The complete package is available via anonymous ftp and is free for non-commercial uses.

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

    Science.gov (United States)

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

    2014-06-10

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

  20. DNA impedance biosensor for detection of cancer, TP53 gene mutation, based on gold nanoparticles/aligned carbon nanotubes modified electrode.

    Science.gov (United States)

    Fayazfar, H; Afshar, A; Dolati, M; Dolati, A

    2014-07-11

    For the first time, a new platform based on electrochemical growth of Au nanoparticles on aligned multi-walled carbon nanotubes (A-MWCNT) was developed for sensitive lable-free DNA detection of the TP53 gene mutation, one of the most popular genes in cancer research. Electrochemical impedance spectroscopy (EIS) was used to monitor the sequence-specific DNA hybridization events related to TP53 gene. Compared to the bare Ta or MWCNT/Ta electrodes, the synergistic interactions of vertically aligned MWCNT array and gold nanoparticles at modified electrode could improve the density of the probe DNA attachment and resulting the sensitivity of the DNA sensor greatly. Using EIS, over the extended DNA concentration range, the change of charge transfer resistance was found to have a linear relationship in respect to the logarithm of the complementary oligonucleotides sequence concentrations in the wide range of 1.0×10(-15)-1.0×10(-7)M, with a detection limit of 1.0×10(-17)M (S/N=3). The prepared sensor also showed good stability (14 days), reproducibility (RSD=2.1%) and could be conveniently regenerated via dehybridization in hot water. The significant improvement in sensitivity illustrates that combining gold nanoparticles with the on-site fabricated aligned MWCNT array represents a promising platform for achieving sensitive biosensor for fast mutation screening related to most human cancer types. Copyright © 2014. Published by Elsevier B.V.

  1. Application of a clustering-based peak alignment algorithm to analyze various DNA fingerprinting data.

    Science.gov (United States)

    Ishii, Satoshi; Kadota, Koji; Senoo, Keishi

    2009-09-01

    DNA fingerprinting analysis such as amplified ribosomal DNA restriction analysis (ARDRA), repetitive extragenic palindromic PCR (rep-PCR), ribosomal intergenic spacer analysis (RISA), and denaturing gradient gel electrophoresis (DGGE) are frequently used in various fields of microbiology. The major difficulty in DNA fingerprinting data analysis is the alignment of multiple peak sets. We report here an R program for a clustering-based peak alignment algorithm, and its application to analyze various DNA fingerprinting data, such as ARDRA, rep-PCR, RISA, and DGGE data. The results obtained by our clustering algorithm and by BioNumerics software showed high similarity. Since several R packages have been established to statistically analyze various biological data, the distance matrix obtained by our R program can be used for subsequent statistical analyses, some of which were not previously performed but are useful in DNA fingerprinting studies.

  2. Image correlation method for DNA sequence alignment.

    Science.gov (United States)

    Curilem Saldías, Millaray; Villarroel Sassarini, Felipe; Muñoz Poblete, Carlos; Vargas Vásquez, Asticio; Maureira Butler, Iván

    2012-01-01

    The complexity of searches and the volume of genomic data make sequence alignment one of bioinformatics most active research areas. New alignment approaches have incorporated digital signal processing techniques. Among these, correlation methods are highly sensitive. This paper proposes a novel sequence alignment method based on 2-dimensional images, where each nucleic acid base is represented as a fixed gray intensity pixel. Query and known database sequences are coded to their pixel representation and sequence alignment is handled as object recognition in a scene problem. Query and database become object and scene, respectively. An image correlation process is carried out in order to search for the best match between them. Given that this procedure can be implemented in an optical correlator, the correlation could eventually be accomplished at light speed. This paper shows an initial research stage where results were "digitally" obtained by simulating an optical correlation of DNA sequences represented as images. A total of 303 queries (variable lengths from 50 to 4500 base pairs) and 100 scenes represented by 100 x 100 images each (in total, one million base pair database) were considered for the image correlation analysis. The results showed that correlations reached very high sensitivity (99.01%), specificity (98.99%) and outperformed BLAST when mutation numbers increased. However, digital correlation processes were hundred times slower than BLAST. We are currently starting an initiative to evaluate the correlation speed process of a real experimental optical correlator. By doing this, we expect to fully exploit optical correlation light properties. As the optical correlator works jointly with the computer, digital algorithms should also be optimized. The results presented in this paper are encouraging and support the study of image correlation methods on sequence alignment.

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

    Science.gov (United States)

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

    2017-07-01

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

  4. DNA sequence+shape kernel enables alignment-free modeling of transcription factor binding.

    Science.gov (United States)

    Ma, Wenxiu; Yang, Lin; Rohs, Remo; Noble, William Stafford

    2017-10-01

    Transcription factors (TFs) bind to specific DNA sequence motifs. Several lines of evidence suggest that TF-DNA binding is mediated in part by properties of the local DNA shape: the width of the minor groove, the relative orientations of adjacent base pairs, etc. Several methods have been developed to jointly account for DNA sequence and shape properties in predicting TF binding affinity. However, a limitation of these methods is that they typically require a training set of aligned TF binding sites. We describe a sequence + shape kernel that leverages DNA sequence and shape information to better understand protein-DNA binding preference and affinity. This kernel extends an existing class of k-mer based sequence kernels, based on the recently described di-mismatch kernel. Using three in vitro benchmark datasets, derived from universal protein binding microarrays (uPBMs), genomic context PBMs (gcPBMs) and SELEX-seq data, we demonstrate that incorporating DNA shape information improves our ability to predict protein-DNA binding affinity. In particular, we observe that (i) the k-spectrum + shape model performs better than the classical k-spectrum kernel, particularly for small k values; (ii) the di-mismatch kernel performs better than the k-mer kernel, for larger k; and (iii) the di-mismatch + shape kernel performs better than the di-mismatch kernel for intermediate k values. The software is available at https://bitbucket.org/wenxiu/sequence-shape.git. rohs@usc.edu or william-noble@uw.edu. Supplementary data are available at Bioinformatics online. © The Author(s) 2017. Published by Oxford University Press.

  5. A Robust Highly Aligned DNA Nanowire Array-Enabled Lithography for Graphene Nanoribbon Transistors.

    Science.gov (United States)

    Kang, Seok Hee; Hwang, Wan Sik; Lin, Zhiqun; Kwon, Se Hun; Hong, Suck Won

    2015-12-09

    Because of its excellent charge carrier mobility at the Dirac point, graphene possesses exceptional properties for high-performance devices. Of particular interest is the potential use of graphene nanoribbons or graphene nanomesh for field-effect transistors. Herein, highly aligned DNA nanowire arrays were crafted by flow-assisted self-assembly of a drop of DNA aqueous solution on a flat polymer substrate. Subsequently, they were exploited as "ink" and transfer-printed on chemical vapor deposited (CVD)-grown graphene substrate. The oriented DNA nanowires served as the lithographic resist for selective removal of graphene, forming highly aligned graphene nanoribbons. Intriguingly, these graphene nanoribbons can be readily produced over a large area (i.e., millimeter scale) with a high degree of feature-size controllability and a low level of defects, rendering the fabrication of flexible two terminal devices and field-effect transistors.

  6. An improved Hough transform-based fingerprint alignment approach

    CSIR Research Space (South Africa)

    Mlambo, CS

    2014-11-01

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

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

    Directory of Open Access Journals (Sweden)

    Liviu P Dinu

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

  8. Phylo: a citizen science approach for improving multiple sequence alignment.

    Directory of Open Access Journals (Sweden)

    Alexander Kawrykow

    Full Text Available BACKGROUND: Comparative genomics, or the study of the relationships of genome structure and function across different species, offers a powerful tool for studying evolution, annotating genomes, and understanding the causes of various genetic disorders. However, aligning multiple sequences of DNA, an essential intermediate step for most types of analyses, is a difficult computational task. In parallel, citizen science, an approach that takes advantage of the fact that the human brain is exquisitely tuned to solving specific types of problems, is becoming increasingly popular. There, instances of hard computational problems are dispatched to a crowd of non-expert human game players and solutions are sent back to a central server. METHODOLOGY/PRINCIPAL FINDINGS: We introduce Phylo, a human-based computing framework applying "crowd sourcing" techniques to solve the Multiple Sequence Alignment (MSA problem. The key idea of Phylo is to convert the MSA problem into a casual game that can be played by ordinary web users with a minimal prior knowledge of the biological context. We applied this strategy to improve the alignment of the promoters of disease-related genes from up to 44 vertebrate species. Since the launch in November 2010, we received more than 350,000 solutions submitted from more than 12,000 registered users. Our results show that solutions submitted contributed to improving the accuracy of up to 70% of the alignment blocks considered. CONCLUSIONS/SIGNIFICANCE: We demonstrate that, combined with classical algorithms, crowd computing techniques can be successfully used to help improving the accuracy of MSA. More importantly, we show that an NP-hard computational problem can be embedded in casual game that can be easily played by people without significant scientific training. This suggests that citizen science approaches can be used to exploit the billions of "human-brain peta-flops" of computation that are spent every day playing games

  9. Innovation, improvement and operations: an exploration of the management of alignment

    NARCIS (Netherlands)

    de Leede, Jan; Looise, Jan C.; Alders, B.C.M.; Alders, Ben C.M.

    2002-01-01

    Based on the assumption that the three functions of operations, improvement and innovation within companies need to be aligned to improve company performance, this article addresses two internal alignment mechanisms structural and social-dynamic alignment. A survey of 267 companies confirms that

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

    Science.gov (United States)

    Swain, Timothy D

    2018-01-01

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

  11. Genomic signal processing methods for computation of alignment-free distances from DNA sequences.

    Science.gov (United States)

    Borrayo, Ernesto; Mendizabal-Ruiz, E Gerardo; Vélez-Pérez, Hugo; Romo-Vázquez, Rebeca; Mendizabal, Adriana P; Morales, J Alejandro

    2014-01-01

    Genomic signal processing (GSP) refers to the use of digital signal processing (DSP) tools for analyzing genomic data such as DNA sequences. A possible application of GSP that has not been fully explored is the computation of the distance between a pair of sequences. In this work we present GAFD, a novel GSP alignment-free distance computation method. We introduce a DNA sequence-to-signal mapping function based on the employment of doublet values, which increases the number of possible amplitude values for the generated signal. Additionally, we explore the use of three DSP distance metrics as descriptors for categorizing DNA signal fragments. Our results indicate the feasibility of employing GAFD for computing sequence distances and the use of descriptors for characterizing DNA fragments.

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

  13. Mediated Electron Transfer at Vertically Aligned Single-Walled Carbon Nanotube Electrodes During Detection of DNA Hybridization

    Science.gov (United States)

    Wallen, Rachel; Gokarn, Nirmal; Bercea, Priscila; Grzincic, Elissa; Bandyopadhyay, Krisanu

    2015-06-01

    Vertically aligned single-walled carbon nanotube (VASWCNT) assemblies are generated on cysteamine and 2-mercaptoethanol (2-ME)-functionalized gold surfaces through amide bond formation between carboxylic groups generated at the end of acid-shortened single-walled carbon nanotubes (SWCNTs) and amine groups present on the gold surfaces. Atomic force microscopy (AFM) imaging confirms the vertical alignment mode of SWCNT attachment through significant changes in surface roughness compared to bare gold surfaces and the lack of any horizontally aligned SWCNTs present. These SWCNT assemblies are further modified with an amine-terminated single-stranded probe-DNA. Subsequent hybridization of the surface-bound probe-DNA in the presence of complementary strands in solution is followed using impedance measurements in the presence of Fe(CN)6 3-/4- as the redox probe in solution, which show changes in the interfacial electrochemical properties, specifically the charge-transfer resistance, due to hybridization. In addition, hybridization of the probe-DNA is also compared when it is attached directly to the gold surfaces without any intermediary SWCNTs. Contrary to our expectations, impedance measurements show a decrease in charge-transfer resistance with time due to hybridization with 300 nM complementary DNA in solution with the probe-DNA attached to SWCNTs. In contrast, an increase in charge-transfer resistance is observed with time during hybridization when the probe-DNA is attached directly to the gold surfaces. The decrease in charge-transfer resistance during hybridization in the presence of VASWCNTs indicates an enhancement in the electron transfer process of the redox probe at the VASWCNT-modified electrode. The results suggest that VASWCNTs are acting as mediators of electron transfer, which facilitate the charge transfer of the redox probe at the electrode-solution interface.

  14. Reverse alignment "mirror image" visualization as a laparoscopic training tool improves task performance.

    Science.gov (United States)

    Dunnican, Ward J; Singh, T Paul; Ata, Ashar; Bendana, Emma E; Conlee, Thomas D; Dolce, Charles J; Ramakrishnan, Rakesh

    2010-06-01

    Reverse alignment (mirror image) visualization is a disconcerting situation occasionally faced during laparoscopic operations. This occurs when the camera faces back at the surgeon in the opposite direction from which the surgeon's body and instruments are facing. Most surgeons will attempt to optimize trocar and camera placement to avoid this situation. The authors' objective was to determine whether the intentional use of reverse alignment visualization during laparoscopic training would improve performance. A standard box trainer was configured for reverse alignment, and 34 medical students and junior surgical residents were randomized to train with either forward alignment (DIRECT) or reverse alignment (MIRROR) visualization. Enrollees were tested on both modalities before and after a 4-week structured training program specific to their modality. Student's t test was used to determine differences in task performance between the 2 groups. Twenty-one participants completed the study (10 DIRECT, 11 MIRROR). There were no significant differences in performance time between DIRECT or MIRROR participants during forward or reverse alignment initial testing. At final testing, DIRECT participants had improved times only in forward alignment performance; they demonstrated no significant improvement in reverse alignment performance. MIRROR participants had significant time improvement in both forward and reverse alignment performance at final testing. Reverse alignment imaging for laparoscopic training improves task performance for both reverse alignment and forward alignment tasks. This may be translated into improved performance in the operating room when faced with reverse alignment situations. Minimal lab training can account for drastic adaptation to this environment.

  15. Improving scanner wafer alignment performance by target optimization

    Science.gov (United States)

    Leray, Philippe; Jehoul, Christiane; Socha, Robert; Menchtchikov, Boris; Raghunathan, Sudhar; Kent, Eric; Schoonewelle, Hielke; Tinnemans, Patrick; Tuffy, Paul; Belen, Jun; Wise, Rich

    2016-03-01

    In the process nodes of 10nm and below, the patterning complexity along with the processing and materials required has resulted in a need to optimize alignment targets in order to achieve the required precision, accuracy and throughput performance. Recent industry publications on the metrology target optimization process have shown a move from the expensive and time consuming empirical methodologies, towards a faster computational approach. ASML's Design for Control (D4C) application, which is currently used to optimize YieldStar diffraction based overlay (DBO) metrology targets, has been extended to support the optimization of scanner wafer alignment targets. This allows the necessary process information and design methodology, used for DBO target designs, to be leveraged for the optimization of alignment targets. In this paper, we show how we applied this computational approach to wafer alignment target design. We verify the correlation between predictions and measurements for the key alignment performance metrics and finally show the potential alignment and overlay performance improvements that an optimized alignment target could achieve.

  16. Effects of dialysate to serum sodium (Na+) alignment in chronic hemodialysis (HD) patients: retrospective cohort study from a quality improvement project.

    Science.gov (United States)

    Raimann, Jochen G; Ficociello, Linda H; Usvyat, Len A; Zhang, Hanjie; Pacelli, Lisa; Moore, Sandi; Sheppard, Penny; Xiao, Qingqing; Wang, Yuedong; Mullon, Claudy; Balter, Paul; Sullivan, Terry; Kotanko, Peter

    2018-04-02

    Evidence indicates favorable effects of dialysate (DNa + ) to serum sodium concentration (SNa + ) alignment, however, results from larger sample populations are needed. For this reason, we conducted a retrospective propensity score-matched cohort study from a quality improvement project to investigate the effects of alignment on population of maintenance hemodialysis patients. At 4 participating hemodialysis (HD) clinics, patients with SNa + lower than the standard DNa + of 137 mEq/L who received HD with DNa + aligned to the average of the last 4 SNa + measurements were evaluated (clinicaltrials.gov # NCT01825590 ). In this retrospective data analysis, an intention-to-treat (primary) and an as-treated "intervention" (secondary) cohort were created. "Aligned" patients from both cohorts (N = 163 for the primary and N = 137 for the secondary) were then propensity-score matched in a 1:1 fashion to "unaligned" patients from the Renal Research Institute database. The propensity score was generated based on age, gender, white race, Hispanic ethnicity, absence or presence of diabetes, hemodialysis vintage, interdialytic weight gain (IDWG; as a percentage of postdialysis body weight), catheter as primary dialysis access, predialysis systolic blood pressure, serum sodium concentration, hospitalization count during baseline. T-Test was employed for group comparisons of changes to the primary (volume-related and hemodynamic parameters) and tertiary outcomes. All-cause and fluid overload-related hospitalization admission rates were compared using Wilcoxon Rank Sum test and Cox regression analysis for repeated events. In the primary analysis, aligned and unaligned subjects showed comparable demographics at baseline. Treatment effects were significant for IDWG [-0.12 (95% CI -0.24 to 0) L] and showed decreasing non-significant trends for pre-dialysis hemodynamic parameters. Count comparison and Cox regression analysis showed no clear advantage of alignment in terms of

  17. Finding optimal interaction interface alignments between biological complexes

    KAUST Repository

    Cui, Xuefeng

    2015-06-13

    Motivation: Biological molecules perform their functions through interactions with other molecules. Structure alignment of interaction interfaces between biological complexes is an indispensable step in detecting their structural similarities, which are keys to understanding their evolutionary histories and functions. Although various structure alignment methods have been developed to successfully access the similarities of protein structures or certain types of interaction interfaces, existing alignment tools cannot directly align arbitrary types of interfaces formed by protein, DNA or RNA molecules. Specifically, they require a \\'blackbox preprocessing\\' to standardize interface types and chain identifiers. Yet their performance is limited and sometimes unsatisfactory. Results: Here we introduce a novel method, PROSTA-inter, that automatically determines and aligns interaction interfaces between two arbitrary types of complex structures. Our method uses sequentially remote fragments to search for the optimal superimposition. The optimal residue matching problem is then formulated as a maximum weighted bipartite matching problem to detect the optimal sequence order-independent alignment. Benchmark evaluation on all non-redundant protein-DNA complexes in PDB shows significant performance improvement of our method over TM-align and iAlign (with the \\'blackbox preprocessing\\'). Two case studies where our method discovers, for the first time, structural similarities between two pairs of functionally related protein-DNA complexes are presented. We further demonstrate the power of our method on detecting structural similarities between a protein-protein complex and a protein-RNA complex, which is biologically known as a protein-RNA mimicry case. © The Author 2015. Published by Oxford University Press.

  18. ABS: Sequence alignment by scanning

    KAUST Repository

    Bonny, Mohamed Talal; Salama, Khaled N.

    2011-01-01

    Sequence alignment is an essential tool in almost any computational biology research. It processes large database sequences and considered to be high consumers of computation time. Heuristic algorithms are used to get approximate but fast results. We introduce fast alignment algorithm, called Alignment By Scanning (ABS), to provide an approximate alignment of two DNA sequences. We compare our algorithm with the well-known alignment algorithms, the FASTA (which is heuristic) and the 'Needleman-Wunsch' (which is optimal). The proposed algorithm achieves up to 76% enhancement in alignment score when it is compared with the FASTA Algorithm. The evaluations are conducted using different lengths of DNA sequences. © 2011 IEEE.

  19. ABS: Sequence alignment by scanning

    KAUST Repository

    Bonny, Mohamed Talal

    2011-08-01

    Sequence alignment is an essential tool in almost any computational biology research. It processes large database sequences and considered to be high consumers of computation time. Heuristic algorithms are used to get approximate but fast results. We introduce fast alignment algorithm, called Alignment By Scanning (ABS), to provide an approximate alignment of two DNA sequences. We compare our algorithm with the well-known alignment algorithms, the FASTA (which is heuristic) and the \\'Needleman-Wunsch\\' (which is optimal). The proposed algorithm achieves up to 76% enhancement in alignment score when it is compared with the FASTA Algorithm. The evaluations are conducted using different lengths of DNA sequences. © 2011 IEEE.

  20. Fast global sequence alignment technique

    KAUST Repository

    Bonny, Mohamed Talal

    2011-11-01

    Bioinformatics database is growing exponentially in size. Processing these large amount of data may take hours of time even if super computers are used. One of the most important processing tool in Bioinformatics is sequence alignment. We introduce fast alignment algorithm, called \\'Alignment By Scanning\\' (ABS), to provide an approximate alignment of two DNA sequences. We compare our algorithm with the wellknown sequence alignment algorithms, the \\'GAP\\' (which is heuristic) and the \\'Needleman-Wunsch\\' (which is optimal). The proposed algorithm achieves up to 51% enhancement in alignment score when it is compared with the GAP Algorithm. The evaluations are conducted using different lengths of DNA sequences. © 2011 IEEE.

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

  2. Fast global sequence alignment technique

    KAUST Repository

    Bonny, Mohamed Talal; Salama, Khaled N.

    2011-01-01

    fast alignment algorithm, called 'Alignment By Scanning' (ABS), to provide an approximate alignment of two DNA sequences. We compare our algorithm with the wellknown sequence alignment algorithms, the 'GAP' (which is heuristic) and the 'Needleman

  3. DNA motif alignment by evolving a population of Markov chains.

    Science.gov (United States)

    Bi, Chengpeng

    2009-01-30

    Deciphering cis-regulatory elements or de novo motif-finding in genomes still remains elusive although much algorithmic effort has been expended. The Markov chain Monte Carlo (MCMC) method such as Gibbs motif samplers has been widely employed to solve the de novo motif-finding problem through sequence local alignment. Nonetheless, the MCMC-based motif samplers still suffer from local maxima like EM. Therefore, as a prerequisite for finding good local alignments, these motif algorithms are often independently run a multitude of times, but without information exchange between different chains. Hence it would be worth a new algorithm design enabling such information exchange. This paper presents a novel motif-finding algorithm by evolving a population of Markov chains with information exchange (PMC), each of which is initialized as a random alignment and run by the Metropolis-Hastings sampler (MHS). It is progressively updated through a series of local alignments stochastically sampled. Explicitly, the PMC motif algorithm performs stochastic sampling as specified by a population-based proposal distribution rather than individual ones, and adaptively evolves the population as a whole towards a global maximum. The alignment information exchange is accomplished by taking advantage of the pooled motif site distributions. A distinct method for running multiple independent Markov chains (IMC) without information exchange, or dubbed as the IMC motif algorithm, is also devised to compare with its PMC counterpart. Experimental studies demonstrate that the performance could be improved if pooled information were used to run a population of motif samplers. The new PMC algorithm was able to improve the convergence and outperformed other popular algorithms tested using simulated and biological motif sequences.

  4. Method and apparatus for improving the alignment of radiographic images

    International Nuclear Information System (INIS)

    Schuller, P.D.; Hatcher, D.C.; Caelli, T.M.; Eggert, F.M.; Yuzyk, J.

    1991-01-01

    This invention relates generally to the field of radiology, and has to do particularly with a method and apparatus for improving the alignment of radiographic images taken at different times of the same tissue structure, so that the images can be sequentially shown in aligned condition, whereby changes in the structure can be noted. (author). 10 figs

  5. Prediction of molecular alignment of nucleic acids in aligned media

    International Nuclear Information System (INIS)

    Wu Bin; Petersen, Michael; Girard, Frederic; Tessari, Marco; Wijmenga, Sybren S.

    2006-01-01

    We demonstrate - using the data base of all deposited DNA and RNA structures aligned in Pf1-medium and RDC refined - that for nucleic acids in a Pf1-medium the electrostatic alignment tensor can be predicted reliably and accurately via a simple and fast calculation based on the gyration tensor spanned out by the phosphodiester atoms. The rhombicity is well predicted over its full range from 0 to 0.66, while the alignment tensor orientation is predicted correctly for rhombicities up to ca. 0.4, for larger rhombicities it appears to deviate somewhat more than expected based on structural noise and measurement error. This simple analytical approach is based on the Debye-Huckel approximation for the electrostatic interaction potential, valid at distances sufficiently far away from a poly-ionic charged surface, a condition naturally enforced when the charge of alignment medium and solute are of equal sign, as for nucleic acids in a Pf1-phage medium. For the usual salt strengths and nucleic acid sizes, the Debye-Huckel screening length is smaller than the nucleic acid size, but large enough for the collective of Debye-Huckel spheres to encompass the whole molecule. The molecular alignment is then purely electrostatic, but it's functional form is under these conditions similar to that for steric alignment. The proposed analytical expression allows for very fast calculation of the alignment tensor and hence RDCs from the conformation of the nucleic acid molecule. This information provides opportunities for improved structure determination of nucleic acids, including better assessment of dynamics in (multi-domain) nucleic acids and the possibility to incorporate alignment tensor prediction from shape directly into the structure calculation process. The procedures are incorporated into MATLAB scripts, which are available on request

  6. Short Oligonucleotides Aligned in Stretched Humid Matrix: Secondary DNA Structure in Poly(vinyl alcohol) Environment

    KAUST Repository

    Hanczyc, Piotr

    2012-04-24

    We report that short, synthetic, double- as well as single-stranded DNA can be aligned in stretched humid poly(vinyl alcohol) (PVA) matrix, and the secondary structure (nucleobase orientation) can be characterized with linear dichroism (LD) spectroscopy. Oligonucleotides of lengths varying between 10 (3.4 nm) and 60 bases (20.4 nm) were investigated with respect to structural properties in the gel-like polymer environment. The DNA conformation as a function of relative humidity reveals a strong dependence of helical structure of DNA on PVA hydration level, results of relevance for nanotechnical studies of DNA-based supramolecular systems. Also, the PVA gel could provide possibilities to test models for nucleic acid interactions and distribution in cell contexts, including structural stability of genetic material in the cell and PVA-packaging for gene delivery. A method by which duplex oligonucleotides, with sequences designed to provide specific binding sites, become amenable to polarized-light spectroscopy opens up new possibilities for studying structure in DNA complexes with small adduct molecules as well as proteins. © 2012 American Chemical Society.

  7. High Throughput Preparation of Aligned Nanofibers Using an Improved Bubble-Electrospinning

    Directory of Open Access Journals (Sweden)

    Liang Yu

    2017-11-01

    Full Text Available An improved bubble-electrospinning, consisting of a cone shaped air nozzle, a copper solution reservoir connected directly to the power generator, and a high speed rotating copper wire drum as a collector, was presented successfully to obtain high throughput preparation of aligned nanofibers. The influences of drum rotation speed on morphology and properties of obtained nanofibers were explored and researched. The results showed that the alignment degree, diameter distribution, and properties of nanofibers were improved with the increase of the drum rotation speed.

  8. Semiautomated improvement of RNA alignments

    DEFF Research Database (Denmark)

    Andersen, Ebbe Sloth; Lind-Thomsen, Allan; Knudsen, Bjarne

    2007-01-01

    connects to external tools to provide a flexible semiautomatic editing environment. A new method, Pcluster, is introduced for dividing the sequences of an RNA alignment into subgroups with secondary structure differences. Pcluster was used to evaluate 574 seed alignments obtained from the Rfam database...... and we identified 71 alignments with significant prediction of inconsistent base pairs and 102 alignments with significant prediction of novel base pairs. Four RNA families were used to illustrate how SARSE can be used to manually or automatically correct the inconsistent base pairs detected by Pcluster......: the mir-399 RNA, vertebrate telomase RNA (vert-TR), bacterial transfer-messenger RNA (tmRNA), and the signal recognition particle (SRP) RNA. The general use of the method is illustrated by the ability to accommodate pseudoknots and handle even large and divergent RNA families. The open architecture...

  9. Measuring covariation in RNA alignments: Physical realism improves information measures

    DEFF Research Database (Denmark)

    Lindgreen, Stinus; Gardner, Paul Phillip; Krogh, Anders

    2006-01-01

    Motivation: The importance of non-coding RNAs is becoming increasingly evident, and often the function of these molecules depends on the structure. It is common to use alignments of related RNA sequences to deduce the consensus secondary structure by detecting patterns of co-evolution. A central...... part of such an analysis is to measure covariation between two positions in an alignment. Here, we rank various measures ranging from simple mutual information to more advanced covariation measures. Results: Mutual information is still used for secondary structure prediction, but the results...... of this study indicate which measures are useful. Incorporating more structural information by considering e.g. indels and stacking improves accuracy, suggesting that physically realistic measures yield improved predictions. This can be used to improve both current and future programs for secondary structure...

  10. Using Variable-Length Aligned Fragment Pairs and an Improved Transition Function for Flexible Protein Structure Alignment.

    Science.gov (United States)

    Cao, Hu; Lu, Yonggang

    2017-01-01

    With the rapid growth of known protein 3D structures in number, how to efficiently compare protein structures becomes an essential and challenging problem in computational structural biology. At present, many protein structure alignment methods have been developed. Among all these methods, flexible structure alignment methods are shown to be superior to rigid structure alignment methods in identifying structure similarities between proteins, which have gone through conformational changes. It is also found that the methods based on aligned fragment pairs (AFPs) have a special advantage over other approaches in balancing global structure similarities and local structure similarities. Accordingly, we propose a new flexible protein structure alignment method based on variable-length AFPs. Compared with other methods, the proposed method possesses three main advantages. First, it is based on variable-length AFPs. The length of each AFP is separately determined to maximally represent a local similar structure fragment, which reduces the number of AFPs. Second, it uses local coordinate systems, which simplify the computation at each step of the expansion of AFPs during the AFP identification. Third, it decreases the number of twists by rewarding the situation where nonconsecutive AFPs share the same transformation in the alignment, which is realized by dynamic programming with an improved transition function. The experimental data show that compared with FlexProt, FATCAT, and FlexSnap, the proposed method can achieve comparable results by introducing fewer twists. Meanwhile, it can generate results similar to those of the FATCAT method in much less running time due to the reduced number of AFPs.

  11. SPA: a probabilistic algorithm for spliced alignment.

    Directory of Open Access Journals (Sweden)

    2006-04-01

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

  12. Coarse Alignment Technology on Moving base for SINS Based on the Improved Quaternion Filter Algorithm.

    Science.gov (United States)

    Zhang, Tao; Zhu, Yongyun; Zhou, Feng; Yan, Yaxiong; Tong, Jinwu

    2017-06-17

    Initial alignment of the strapdown inertial navigation system (SINS) is intended to determine the initial attitude matrix in a short time with certain accuracy. The alignment accuracy of the quaternion filter algorithm is remarkable, but the convergence rate is slow. To solve this problem, this paper proposes an improved quaternion filter algorithm for faster initial alignment based on the error model of the quaternion filter algorithm. The improved quaternion filter algorithm constructs the K matrix based on the principle of optimal quaternion algorithm, and rebuilds the measurement model by containing acceleration and velocity errors to make the convergence rate faster. A doppler velocity log (DVL) provides the reference velocity for the improved quaternion filter alignment algorithm. In order to demonstrate the performance of the improved quaternion filter algorithm in the field, a turntable experiment and a vehicle test are carried out. The results of the experiments show that the convergence rate of the proposed improved quaternion filter is faster than that of the tradition quaternion filter algorithm. In addition, the improved quaternion filter algorithm also demonstrates advantages in terms of correctness, effectiveness, and practicability.

  13. Mixed DNA/Oligo(ethylene glycol) Functionalized Gold Surface Improve DNA Hybridization in Complex Media

    International Nuclear Information System (INIS)

    Lee, C.; Gamble, L.; Grainger, D.; Castner, D.

    2006-01-01

    Reliable, direct 'sample-to-answer' capture of nucleic acid targets from complex media would greatly improve existing capabilities of DNA microarrays and biosensors. This goal has proven elusive for many current nucleic acid detection technologies attempting to produce assay results directly from complex real-world samples, including food, tissue, and environmental materials. In this study, we have investigated mixed self-assembled thiolated single-strand DNA (ssDNA) monolayers containing a short thiolated oligo(ethylene glycol) (OEG) surface diluent on gold surfaces to improve the specific capture of DNA targets from complex media. Both surface composition and orientation of these mixed DNA monolayers were characterized with x-ray photoelectron spectroscopy (XPS) and near-edge x-ray absorption fine structure (NEXAFS). XPS results from sequentially adsorbed ssDNA/OEG monolayers on gold indicate that thiolated OEG diluent molecules first incorporate into the thiolated ssDNA monolayer and, upon longer OEG exposures, competitively displace adsorbed ssDNA molecules from the gold surface. NEXAFS polarization dependence results (followed by monitoring the N 1s→π* transition) indicate that adsorbed thiolated ssDNA nucleotide base-ring structures in the mixed ssDNA monolayers are oriented more parallel to the gold surface compared to DNA bases in pure ssDNA monolayers. This supports ssDNA oligomer reorientation towards a more upright position upon OEG mixed adlayer incorporation. DNA target hybridization on mixed ssDNA probe/OEG monolayers was monitored by surface plasmon resonance (SPR). Improvements in specific target capture for these ssDNA probe surfaces due to incorporation of the OEG diluent were demonstrated using two model biosensing assays, DNA target capture from complete bovine serum and from salmon genomic DNA mixtures. SPR results demonstrate that OEG incorporation into the ssDNA adlayer improves surface resistance to both nonspecific DNA and protein

  14. Assessing strategic alignment to improve IT effectiveness

    NARCIS (Netherlands)

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

    2009-01-01

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

  15. Requirement for XLF/Cernunnos in alignment-based gap filling by DNA polymerases lambda and mu for nonhomologous end joining in human whole-cell extracts.

    Science.gov (United States)

    Akopiants, Konstantin; Zhou, Rui-Zhe; Mohapatra, Susovan; Valerie, Kristoffer; Lees-Miller, Susan P; Lee, Kyung-Jong; Chen, David J; Revy, Patrick; de Villartay, Jean-Pierre; Povirk, Lawrence F

    2009-07-01

    XLF/Cernunnos is a core protein of the nonhomologous end-joining pathway of DNA double-strand break repair. To better define the role of Cernunnos in end joining, whole-cell extracts were prepared from Cernunnos-deficient human cells. These extracts effected little joining of DNA ends with cohesive 5' or 3' overhangs, and no joining at all of partially complementary 3' overhangs that required gap filling prior to ligation. Assays in which gap-filled but unligated intermediates were trapped using dideoxynucleotides revealed that there was no gap filling on aligned DSB ends in the Cernunnos-deficient extracts. Recombinant Cernunnos protein restored gap filling and end joining of partially complementary overhangs, and stimulated joining of cohesive ends more than twentyfold. XLF-dependent gap filling was nearly eliminated by immunodepletion of DNA polymerase lambda, but was restored by addition of either polymerase lambda or polymerase mu. Thus, Cernunnos is essential for gap filling by either polymerase during nonhomologous end joining, suggesting that it plays a major role in aligning the two DNA ends in the repair complex.

  16. Improving your target-template alignment with MODalign.

    KAUST Repository

    Barbato, Alessandro

    2012-02-04

    SUMMARY: MODalign is an interactive web-based tool aimed at helping protein structure modelers to inspect and manually modify the alignment between the sequences of a target protein and of its template(s). It interactively computes, displays and, upon modification of the target-template alignment, updates the multiple sequence alignments of the two protein families, their conservation score, secondary structure and solvent accessibility values, and local quality scores of the implied three-dimensional model(s). Although it has been designed to simplify the target-template alignment step in modeling, it is suitable for all cases where a sequence alignment needs to be inspected in the context of other biological information. AVAILABILITY AND IMPLEMENTATION: Freely available on the web at http://modorama.biocomputing.it/modalign. Website implemented in HTML and JavaScript with all major browsers supported. CONTACT: jan.kosinski@uniroma1.it.

  17. Improved recovery of DNA from polyacrylamide gels after in situ DNA footprinting

    NARCIS (Netherlands)

    van Keulen, G; Meijer, WG

    Methods used to date for the isolation of DNA from polyacrylamide gels are elution based, time-consuming and with low yield in DNA. This paper describes an improved system employing polyacrylamide gels made of a meltable matrix. The new system was successfully applied to in situ DNA footprinting

  18. Improved production of Br atoms near zero speed by photodissociating laser aligned Br2 molecules.

    Science.gov (United States)

    Deng, L Z; Yin, J P

    2014-10-28

    We theoretically investigated the improvement on the production rate of the decelerated bromine (Br) atoms near zero speed by photodissociating laser aligned Br2 precursors. Adiabatic alignment of Br2 precursors exposed to long laser pulses with duration on the order of nanoseconds was investigated by solving the time-dependent Schrödinger equation. The dynamical fragmentation of adiabatically aligned Br2 precursors was simulated and velocity distribution of the Br atoms produced was analyzed. Our study shows that the larger the degree of the precursor alignment, ⟨cos(2) θ⟩, the higher the production rate of the decelerated Br atoms near zero speed. For Br2 molecules with an initial rotational temperature of ~1 K, a ⟨cos(2) θ⟩ value of ~0.88 can result in an improvement factor of over ~20 on the production rate of the decelerated Br atoms near zero speed, requiring a laser intensity of only ~1 × 10(12) W/cm(2) for alignment.

  19. Parametric and non-parametric masking of randomness in sequence alignments can be improved and leads to better resolved trees

    Directory of Open Access Journals (Sweden)

    von Reumont Björn M

    2010-03-01

    Full Text Available Abstract Background Methods of alignment masking, which refers to the technique of excluding alignment blocks prior to tree reconstructions, have been successful in improving the signal-to-noise ratio in sequence alignments. However, the lack of formally well defined methods to identify randomness in sequence alignments has prevented a routine application of alignment masking. In this study, we compared the effects on tree reconstructions of the most commonly used profiling method (GBLOCKS which uses a predefined set of rules in combination with alignment masking, with a new profiling approach (ALISCORE based on Monte Carlo resampling within a sliding window, using different data sets and alignment methods. While the GBLOCKS approach excludes variable sections above a certain threshold which choice is left arbitrary, the ALISCORE algorithm is free of a priori rating of parameter space and therefore more objective. Results ALISCORE was successfully extended to amino acids using a proportional model and empirical substitution matrices to score randomness in multiple sequence alignments. A complex bootstrap resampling leads to an even distribution of scores of randomly similar sequences to assess randomness of the observed sequence similarity. Testing performance on real data, both masking methods, GBLOCKS and ALISCORE, helped to improve tree resolution. The sliding window approach was less sensitive to different alignments of identical data sets and performed equally well on all data sets. Concurrently, ALISCORE is capable of dealing with different substitution patterns and heterogeneous base composition. ALISCORE and the most relaxed GBLOCKS gap parameter setting performed best on all data sets. Correspondingly, Neighbor-Net analyses showed the most decrease in conflict. Conclusions Alignment masking improves signal-to-noise ratio in multiple sequence alignments prior to phylogenetic reconstruction. Given the robust performance of alignment

  20. EURRECA: development of tools to improve the alignment of micronutrient recommendations

    NARCIS (Netherlands)

    Matthys, C.; Bucchini, L.; Busstra, M.C.; Cavelaars, A.J.E.M.; Eleftheriou, P.; Garcia-Alvarez, A.; Fairweather-Tait, S.; Gurinovic, M.; Ommen, van B.; Contor, L.

    2010-01-01

    Approaches through which reference values for micronutrients are derived, as well as the reference values themselves, vary considerably across countries. Harmonisation is needed to improve nutrition policy and public health strategies. The EURRECA (EURopean micronutrient RECommendations Aligned,

  1. Improving your target-template alignment with MODalign

    OpenAIRE

    Barbato, Alessandro; Benkert, Pascal; Schwede, Torsten; Tramontano, Anna; Kosinski, Jan

    2012-01-01

    Summary: MODalign is an interactive web-based tool aimed at helping protein structure modelers to inspect and manually modify the alignment between the sequences of a target protein and of its template(s). It interactively computes, displays and, upon modification of the target-template alignment, updates the multiple sequence alignments of the two protein families, their conservation score, secondary structure and solvent accessibility values, and local quality scores of the implied three-di...

  2. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez

    2010-01-01

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

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

    Directory of Open Access Journals (Sweden)

    Zaverucha Gerson

    2007-11-01

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

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

    Science.gov (United States)

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

    2007-11-09

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

  5. Design Pattern Mining Using Distributed Learning Automata and DNA Sequence Alignment

    Science.gov (United States)

    Esmaeilpour, Mansour; Naderifar, Vahideh; Shukur, Zarina

    2014-01-01

    Context Over the last decade, design patterns have been used extensively to generate reusable solutions to frequently encountered problems in software engineering and object oriented programming. A design pattern is a repeatable software design solution that provides a template for solving various instances of a general problem. Objective This paper describes a new method for pattern mining, isolating design patterns and relationship between them; and a related tool, DLA-DNA for all implemented pattern and all projects used for evaluation. DLA-DNA achieves acceptable precision and recall instead of other evaluated tools based on distributed learning automata (DLA) and deoxyribonucleic acid (DNA) sequences alignment. Method The proposed method mines structural design patterns in the object oriented source code and extracts the strong and weak relationships between them, enabling analyzers and programmers to determine the dependency rate of each object, component, and other section of the code for parameter passing and modular programming. The proposed model can detect design patterns better that available other tools those are Pinot, PTIDEJ and DPJF; and the strengths of their relationships. Results The result demonstrate that whenever the source code is build standard and non-standard, based on the design patterns, then the result of the proposed method is near to DPJF and better that Pinot and PTIDEJ. The proposed model is tested on the several source codes and is compared with other related models and available tools those the results show the precision and recall of the proposed method, averagely 20% and 9.6% are more than Pinot, 27% and 31% are more than PTIDEJ and 3.3% and 2% are more than DPJF respectively. Conclusion The primary idea of the proposed method is organized in two following steps: the first step, elemental design patterns are identified, while at the second step, is composed to recognize actual design patterns. PMID:25243670

  6. Design pattern mining using distributed learning automata and DNA sequence alignment.

    Directory of Open Access Journals (Sweden)

    Mansour Esmaeilpour

    Full Text Available CONTEXT: Over the last decade, design patterns have been used extensively to generate reusable solutions to frequently encountered problems in software engineering and object oriented programming. A design pattern is a repeatable software design solution that provides a template for solving various instances of a general problem. OBJECTIVE: This paper describes a new method for pattern mining, isolating design patterns and relationship between them; and a related tool, DLA-DNA for all implemented pattern and all projects used for evaluation. DLA-DNA achieves acceptable precision and recall instead of other evaluated tools based on distributed learning automata (DLA and deoxyribonucleic acid (DNA sequences alignment. METHOD: The proposed method mines structural design patterns in the object oriented source code and extracts the strong and weak relationships between them, enabling analyzers and programmers to determine the dependency rate of each object, component, and other section of the code for parameter passing and modular programming. The proposed model can detect design patterns better that available other tools those are Pinot, PTIDEJ and DPJF; and the strengths of their relationships. RESULTS: The result demonstrate that whenever the source code is build standard and non-standard, based on the design patterns, then the result of the proposed method is near to DPJF and better that Pinot and PTIDEJ. The proposed model is tested on the several source codes and is compared with other related models and available tools those the results show the precision and recall of the proposed method, averagely 20% and 9.6% are more than Pinot, 27% and 31% are more than PTIDEJ and 3.3% and 2% are more than DPJF respectively. CONCLUSION: The primary idea of the proposed method is organized in two following steps: the first step, elemental design patterns are identified, while at the second step, is composed to recognize actual design patterns.

  7. Design pattern mining using distributed learning automata and DNA sequence alignment.

    Science.gov (United States)

    Esmaeilpour, Mansour; Naderifar, Vahideh; Shukur, Zarina

    2014-01-01

    Over the last decade, design patterns have been used extensively to generate reusable solutions to frequently encountered problems in software engineering and object oriented programming. A design pattern is a repeatable software design solution that provides a template for solving various instances of a general problem. This paper describes a new method for pattern mining, isolating design patterns and relationship between them; and a related tool, DLA-DNA for all implemented pattern and all projects used for evaluation. DLA-DNA achieves acceptable precision and recall instead of other evaluated tools based on distributed learning automata (DLA) and deoxyribonucleic acid (DNA) sequences alignment. The proposed method mines structural design patterns in the object oriented source code and extracts the strong and weak relationships between them, enabling analyzers and programmers to determine the dependency rate of each object, component, and other section of the code for parameter passing and modular programming. The proposed model can detect design patterns better that available other tools those are Pinot, PTIDEJ and DPJF; and the strengths of their relationships. The result demonstrate that whenever the source code is build standard and non-standard, based on the design patterns, then the result of the proposed method is near to DPJF and better that Pinot and PTIDEJ. The proposed model is tested on the several source codes and is compared with other related models and available tools those the results show the precision and recall of the proposed method, averagely 20% and 9.6% are more than Pinot, 27% and 31% are more than PTIDEJ and 3.3% and 2% are more than DPJF respectively. The primary idea of the proposed method is organized in two following steps: the first step, elemental design patterns are identified, while at the second step, is composed to recognize actual design patterns.

  8. DNA hosted and aligned in aqueous interstitia of a lamellar liquid crystal – a membrane–biomacromolecule interaction model system

    KAUST Repository

    Carlsson, Nils; Jonsson, Fabian; Wilhelmsson, L. Marcus; Nordé n, Bengt; Å kerman, Bjö rn

    2013-01-01

    We report that DNA molecules can be intercalated and macroscopically oriented in the aqueous interstitia of a lyotropic lamellar liquid crystal. Using UV-vis linear dichroism and fluorescence spectroscopy we show that double-stranded oligonucleotides (25 base pairs) in the water-octanoate-decanol system remain base-paired in the B conformation and are confined in two dimensions, with the helix axis preferentially parallel to the lipid bilayer surfaces but free to rotate within this plane. The degree of helix confinement and the corresponding 2-D orientation can be improved by decreasing the thickness of the water interstitia via the fraction of water in the ternary mixture. Not surprisingly, the corresponding single-stranded oligonucleotides are not aligned, with their persistence length being short in comparison to the lamellar interstitium thickness. We propose this as a model system for studying interactions of DNA-ligand complexes near a lipid bilayer membrane which we demonstrate by using dye probes that are either covalently attached to one end of the oligonucleotide or reversibly bound by intercalation between the base pairs. Three cationic dyes, all strongly bound by intercalation to DNA when free in solution, are found to not bind to DNA but to prefer the membrane surface. The covalently attached Cy5 also binds to the bilayer while Cy3 tends to end-stack to the oligonucleotide duplex. The orientation of Cy5 parallel to the membrane indicates that electrostatic surface binding predominates over insertion into the hydrophobic interior of the membrane. Anionic and zwitterionic dyes (FAM and ROX) are found to remain randomly oriented in the water between the lipid bilayer surfaces. © The Royal Society of Chemistry.

  9. Improving your target-template alignment with MODalign.

    KAUST Repository

    Barbato, Alessandro; Benkert, Pascal; Schwede, Torsten; Tramontano, Anna; Kosinski, Jan

    2012-01-01

    , upon modification of the target-template alignment, updates the multiple sequence alignments of the two protein families, their conservation score, secondary structure and solvent accessibility values, and local quality scores of the implied three

  10. Improving the performance of the actinic inspection tool with an optimized alignment procedure

    International Nuclear Information System (INIS)

    Mochi, I.; Goldberg, K.A.; Naulleau, P.; Huh, Sungmin

    2009-01-01

    Extreme ultraviolet (EUV) microscopy is an important tool for the investigation of the performance of EUV masks, for detecting the presence and the characteristics of defects, and for evaluating the effectiveness of defect repair techniques. Aerial image measurement bypasses the difficulties inherent to photoresist imaging and enables high data collection speed and flexibility. It provides reliable and quick feedback for the development of masks and lithography system modeling methods. We operate the SEMATECH Berkeley Actinic Inspection Tool (AIT), a EUV microscope installed at the Advanced Light Source at Lawrence Berkeley National Laboratory. The AIT is equipped with several high-magnification Fresnel zoneplate lenses, with various numerical aperture values, that enable it image the reflective mask surface with various resolution and magnification settings. Although the AIT has undergone significant recent improvements in terms of imaging resolution and illumination uniformity, there is still room for improvement. In the AIT, an off-axis zoneplate lens collects the light coming from the sample and an image of the sample is projected onto an EUV-sensitive CCD camera. The simplicity of the optical system is particularly helpful considering that the AIT alignment has to be performed every time that a sample or a zoneplate is replaced. The alignment is sensitive to several parameters such as the lens position and orientation, the illumination direction and the sample characteristics. Since the AIT works in high vacuum, there is no direct access to the optics or to the sample during the alignment and the measurements. For all these reasons the alignment procedures and feedback can be complex, and in some cases can reduce the overall data throughput of the system. In this paper we review the main strategies and procedures that have been developed for quick and reliable alignments, and we describe the performance improvements we have achieved, in terms of aberration

  11. Improving the performance of the actinic inspection tool with an optimized alignment procedure

    Energy Technology Data Exchange (ETDEWEB)

    Mochi, I.; Goldberg, K.A.; Naulleau, P.; Huh, Sungmin

    2009-03-04

    Extreme ultraviolet (EUV) microscopy is an important tool for the investigation of the performance of EUV masks, for detecting the presence and the characteristics of defects, and for evaluating the effectiveness of defect repair techniques. Aerial image measurement bypasses the difficulties inherent to photoresist imaging and enables high data collection speed and flexibility. It provides reliable and quick feedback for the development of masks and lithography system modeling methods. We operate the SEMATECH Berkeley Actinic Inspection Tool (AIT), a EUV microscope installed at the Advanced Light Source at Lawrence Berkeley National Laboratory. The AIT is equipped with several high-magnification Fresnel zoneplate lenses, with various numerical aperture values, that enable it image the reflective mask surface with various resolution and magnification settings. Although the AIT has undergone significant recent improvements in terms of imaging resolution and illumination uniformity, there is still room for improvement. In the AIT, an off-axis zoneplate lens collects the light coming from the sample and an image of the sample is projected onto an EUV-sensitive CCD camera. The simplicity of the optical system is particularly helpful considering that the AIT alignment has to be performed every time that a sample or a zoneplate is replaced. The alignment is sensitive to several parameters such as the lens position and orientation, the illumination direction and the sample characteristics. Since the AIT works in high vacuum, there is no direct access to the optics or to the sample during the alignment and the measurements. For all these reasons the alignment procedures and feedback can be complex, and in some cases can reduce the overall data throughput of the system. In this paper we review the main strategies and procedures that have been developed for quick and reliable alignments, and we describe the performance improvements we have achieved, in terms of aberration

  12. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    Gervasio Gomez

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

  13. A generalized global alignment algorithm.

    Science.gov (United States)

    Huang, Xiaoqiu; Chao, Kun-Mao

    2003-01-22

    Homologous sequences are sometimes similar over some regions but different over other regions. Homologous sequences have a much lower global similarity if the different regions are much longer than the similar regions. We present a generalized global alignment algorithm for comparing sequences with intermittent similarities, an ordered list of similar regions separated by different regions. A generalized global alignment model is defined to handle sequences with intermittent similarities. A dynamic programming algorithm is designed to compute an optimal general alignment in time proportional to the product of sequence lengths and in space proportional to the sum of sequence lengths. The algorithm is implemented as a computer program named GAP3 (Global Alignment Program Version 3). The generalized global alignment model is validated by experimental results produced with GAP3 on both DNA and protein sequences. The GAP3 program extends the ability of standard global alignment programs to recognize homologous sequences of lower similarity. The GAP3 program is freely available for academic use at http://bioinformatics.iastate.edu/aat/align/align.html.

  14. High Performance Systolic Array Core Architecture Design for DNA Sequencer

    Directory of Open Access Journals (Sweden)

    Saiful Nurdin Dayana

    2018-01-01

    Full Text Available This paper presents a high performance systolic array (SA core architecture design for Deoxyribonucleic Acid (DNA sequencer. The core implements the affine gap penalty score Smith-Waterman (SW algorithm. This time-consuming local alignment algorithm guarantees optimal alignment between DNA sequences, but it requires quadratic computation time when performed on standard desktop computers. The use of linear SA decreases the time complexity from quadratic to linear. In addition, with the exponential growth of DNA databases, the SA architecture is used to overcome the timing issue. In this work, the SW algorithm has been captured using Verilog Hardware Description Language (HDL and simulated using Xilinx ISIM simulator. The proposed design has been implemented in Xilinx Virtex -6 Field Programmable Gate Array (FPGA and improved in the core area by 90% reduction.

  15. Improving tibial component coronal alignment during total knee arthroplasty with use of a tibial planing device.

    Science.gov (United States)

    Patil, Shantanu; D'Lima, Darryl D; Fait, James M; Colwell, Clifford W

    2007-02-01

    The outcomes of knee arthroplasty have been shown to be affected by component alignment. Intramedullary and extramedullary alignment instrumentation are fairly effective for achieving the desired mean tibial component coronal alignment. However, there are outliers representing >3 degrees of varus or valgus alignment with respect to the anatomic tibial shaft axis. We measured the efficacy of a custom tibial planing device for reducing the outliers in tibial alignment. We designed a tibial planing tool in an effort to improve tibial alignment. In one cohort (100 knees), we used traditional intramedullary alignment instrumentation to make the tibial bone cut. In a second cohort (120 knees), we used intramedullary alignment instrumentation to make the cut and also used a custom tool to check the cut and to correct an inexact cut. Tibial tray alignment relative to the long axis of the tibial shaft was measured in the coronal and sagittal planes on postoperative radiographs. The target coronal alignment was 90 degrees with respect to the tibial shaft axis (with alignment). A total of 100 anteroposterior radiographs and sixty-five lateral radiographs were analyzed for the group that was treated with traditional instrumentation alone, and a total of 120 anteroposterior radiographs and fifty-five lateral radiographs were analyzed for the group that was treated with use of the custom tibial planing device. The mean coronal alignment of the tibial component was 89.5 degrees +/- 2.1 degrees in the group that was treated with traditional instrumentation alone and 89.6 degrees +/- 1.4 degrees in the group that was treated with use of the custom planing device. Although the mean coronal alignment was not significantly different, the number of outliers was substantially reduced when the custom planing device was used. All 120 components that had been aligned with use of the custom planing device were within 3 degrees of the target coronal alignment, compared with only eighty

  16. Enzyme sequence similarity improves the reaction alignment method for cross-species pathway comparison

    Energy Technology Data Exchange (ETDEWEB)

    Ovacik, Meric A. [Chemical and Biochemical Engineering Department, Rutgers University, Piscataway, NJ 08854 (United States); Androulakis, Ioannis P., E-mail: yannis@rci.rutgers.edu [Chemical and Biochemical Engineering Department, Rutgers University, Piscataway, NJ 08854 (United States); Biomedical Engineering Department, Rutgers University, Piscataway, NJ 08854 (United States)

    2013-09-15

    Pathway-based information has become an important source of information for both establishing evolutionary relationships and understanding the mode of action of a chemical or pharmaceutical among species. Cross-species comparison of pathways can address two broad questions: comparison in order to inform evolutionary relationships and to extrapolate species differences used in a number of different applications including drug and toxicity testing. Cross-species comparison of metabolic pathways is complex as there are multiple features of a pathway that can be modeled and compared. Among the various methods that have been proposed, reaction alignment has emerged as the most successful at predicting phylogenetic relationships based on NCBI taxonomy. We propose an improvement of the reaction alignment method by accounting for sequence similarity in addition to reaction alignment method. Using nine species, including human and some model organisms and test species, we evaluate the standard and improved comparison methods by analyzing glycolysis and citrate cycle pathways conservation. In addition, we demonstrate how organism comparison can be conducted by accounting for the cumulative information retrieved from nine pathways in central metabolism as well as a more complete study involving 36 pathways common in all nine species. Our results indicate that reaction alignment with enzyme sequence similarity results in a more accurate representation of pathway specific cross-species similarities and differences based on NCBI taxonomy.

  17. Enzyme sequence similarity improves the reaction alignment method for cross-species pathway comparison

    International Nuclear Information System (INIS)

    Ovacik, Meric A.; Androulakis, Ioannis P.

    2013-01-01

    Pathway-based information has become an important source of information for both establishing evolutionary relationships and understanding the mode of action of a chemical or pharmaceutical among species. Cross-species comparison of pathways can address two broad questions: comparison in order to inform evolutionary relationships and to extrapolate species differences used in a number of different applications including drug and toxicity testing. Cross-species comparison of metabolic pathways is complex as there are multiple features of a pathway that can be modeled and compared. Among the various methods that have been proposed, reaction alignment has emerged as the most successful at predicting phylogenetic relationships based on NCBI taxonomy. We propose an improvement of the reaction alignment method by accounting for sequence similarity in addition to reaction alignment method. Using nine species, including human and some model organisms and test species, we evaluate the standard and improved comparison methods by analyzing glycolysis and citrate cycle pathways conservation. In addition, we demonstrate how organism comparison can be conducted by accounting for the cumulative information retrieved from nine pathways in central metabolism as well as a more complete study involving 36 pathways common in all nine species. Our results indicate that reaction alignment with enzyme sequence similarity results in a more accurate representation of pathway specific cross-species similarities and differences based on NCBI taxonomy

  18. Improving Business-IT Alignment through Business Architecture

    Science.gov (United States)

    Li, Chingmei

    2010-01-01

    The business and Information Technology (IT) alignment issue has become one of the Top-10 IT management issues since 1980. IT has continually strived to achieve alignment with business goals and objectives. These IT efforts include ERP implementation to benefit from the best practices; data center consolidation and server virtualization to keep…

  19. Swi5-Sfr1 protein stimulates Rad51-mediated DNA strand exchange reaction through organization of DNA bases in the presynaptic filament.

    KAUST Repository

    Fornander, Louise H

    2013-12-03

    The Swi5-Sfr1 heterodimer protein stimulates the Rad51-promoted DNA strand exchange reaction, a crucial step in homologous recombination. To clarify how this accessory protein acts on the strand exchange reaction, we have analyzed how the structure of the primary reaction intermediate, the Rad51/single-stranded DNA (ssDNA) complex filament formed in the presence of ATP, is affected by Swi5-Sfr1. Using flow linear dichroism spectroscopy, we observe that the nucleobases of the ssDNA are more perpendicularly aligned to the filament axis in the presence of Swi5-Sfr1, whereas the bases are more randomly oriented in the absence of Swi5-Sfr1. When using a modified version of the natural protein where the N-terminal part of Sfr1 is deleted, which has no affinity for DNA but maintained ability to stimulate the strand exchange reaction, we still observe the improved perpendicular DNA base orientation. This indicates that Swi5-Sfr1 exerts its activating effect through interaction with the Rad51 filament mainly and not with the DNA. We propose that the role of a coplanar alignment of nucleobases induced by Swi5-Sfr1 in the presynaptic Rad51/ssDNA complex is to facilitate the critical matching with an invading double-stranded DNA, hence stimulating the strand exchange reaction.

  20. Designing universal primers for the isolation of DNA sequences encoding Proanthocyanidins biosynthetic enzymes in Crataegus aronia

    Directory of Open Access Journals (Sweden)

    Zuiter Afnan

    2012-08-01

    Full Text Available Abstract Background Hawthorn is the common name of all plant species in the genus Crataegus, which belongs to the Rosaceae family. Crataegus are considered useful medicinal plants because of their high content of proanthocyanidins (PAs and other related compounds. To improve PAs production in Crataegus tissues, the sequences of genes encoding PAs biosynthetic enzymes are required. Findings Different bioinformatics tools, including BLAST, multiple sequence alignment and alignment PCR analysis were used to design primers suitable for the amplification of DNA fragments from 10 candidate genes encoding enzymes involved in PAs biosynthesis in C. aronia. DNA sequencing results proved the utility of the designed primers. The primers were used successfully to amplify DNA fragments of different PAs biosynthesis genes in different Rosaceae plants. Conclusion To the best of our knowledge, this is the first use of the alignment PCR approach to isolate DNA sequences encoding PAs biosynthetic enzymes in Rosaceae plants.

  1. Improved understanding of protein complex offers insight into DNA

    Science.gov (United States)

    Summer Science Writing Internship Improved understanding of protein complex offers insight into DNA clearer understanding of the origin recognition complex (ORC) - a protein complex that directs DNA replication - through its crystal structure offers new insight into fundamental mechanisms of DNA replication

  2. Background Adjusted Alignment-Free Dissimilarity Measures Improve the Detection of Horizontal Gene Transfer

    Directory of Open Access Journals (Sweden)

    Kujin Tang

    2018-04-01

    Full Text Available Horizontal gene transfer (HGT plays an important role in the evolution of microbial organisms including bacteria. Alignment-free methods based on single genome compositional information have been used to detect HGT. Currently, Manhattan and Euclidean distances based on tetranucleotide frequencies are the most commonly used alignment-free dissimilarity measures to detect HGT. By testing on simulated bacterial sequences and real data sets with known horizontal transferred genomic regions, we found that more advanced alignment-free dissimilarity measures such as CVTree and d2* that take into account the background Markov sequences can solve HGT detection problems with significantly improved performance. We also studied the influence of different factors such as evolutionary distance between host and donor sequences, size of sliding window, and host genome composition on the performances of alignment-free methods to detect HGT. Our study showed that alignment-free methods can predict HGT accurately when host and donor genomes are in different order levels. Among all methods, CVTree with word length of 3, d2* with word length 3, Markov order 1 and d2* with word length 4, Markov order 1 outperform others in terms of their highest F1-score and their robustness under the influence of different factors.

  3. Computer navigation experience in hip resurfacing improves femoral component alignment using a conventional jig.

    Science.gov (United States)

    Morison, Zachary; Mehra, Akshay; Olsen, Michael; Donnelly, Michael; Schemitsch, Emil

    2013-11-01

    The use of computer navigation has been shown to improve the accuracy of femoral component placement compared to conventional instrumentation in hip resurfacing. Whether exposure to computer navigation improves accuracy when the procedure is subsequently performed with conventional instrumentation without navigation has not been explored. We examined whether femoral component alignment utilizing a conventional jig improves following experience with the use of imageless computer navigation for hip resurfacing. Between December 2004 and December 2008, 213 consecutive hip resurfacings were performed by a single surgeon. The first 17 (Cohort 1) and the last 9 (Cohort 2) hip resurfacings were performed using a conventional guidewire alignment jig. In 187 cases, the femoral component was implanted using the imageless computer navigation. Cohorts 1 and 2 were compared for femoral component alignment accuracy. All components in Cohort 2 achieved the position determined by the preoperative plan. The mean deviation of the stem-shaft angle (SSA) from the preoperatively planned target position was 2.2° in Cohort 2 and 5.6° in Cohort 1 (P = 0.01). Four implants in Cohort 1 were positioned at least 10° varus compared to the target SSA position and another four were retroverted. Femoral component placement utilizing conventional instrumentation may be more accurate following experience using imageless computer navigation.

  4. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez

    2012-01-01

      A new muon alignment has been produced for 2012 A+B data reconstruction. It uses the latest Tracker alignment and single-muon data samples to align both DTs and CSCs. Physics validation has been performed and shows a modest improvement in stand-alone muon momentum resolution in the barrel, where the alignment is essentially unchanged from the previous version. The reference-target track-based algorithm using only collision muons is employed for the first time to align the CSCs, and a substantial improvement in resolution is observed in the endcap and overlap regions for stand-alone muons. This new alignment is undergoing the approval process and is expected to be deployed as part of a new global tag in the beginning of December. The pT dependence of the φ-bias in curvature observed in Monte Carlo was traced to a relative vertical misalignment between the Tracker and barrel muon systems. Moving the barrel as a whole to match the Tracker cures this pT dependence, leaving only the &phi...

  5. Aligning the unalignable: bacteriophage whole genome alignments.

    Science.gov (United States)

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

    2016-01-13

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

  6. MSuPDA: A Memory Efficient Algorithm for Sequence Alignment.

    Science.gov (United States)

    Khan, Mohammad Ibrahim; Kamal, Md Sarwar; Chowdhury, Linkon

    2016-03-01

    Space complexity is a million dollar question in DNA sequence alignments. In this regard, memory saving under pushdown automata can help to reduce the occupied spaces in computer memory. Our proposed process is that anchor seed (AS) will be selected from given data set of nucleotide base pairs for local sequence alignment. Quick splitting techniques will separate the AS from all the DNA genome segments. Selected AS will be placed to pushdown automata's (PDA) input unit. Whole DNA genome segments will be placed into PDA's stack. AS from input unit will be matched with the DNA genome segments from stack of PDA. Match, mismatch and indel of nucleotides will be popped from the stack under the control unit of pushdown automata. During the POP operation on stack, it will free the memory cell occupied by the nucleotide base pair.

  7. Improved accuracy of multiple ncRNA alignment by incorporating structural information into a MAFFT-based framework

    Directory of Open Access Journals (Sweden)

    Toh Hiroyuki

    2008-04-01

    Full Text Available Abstract Background Structural alignment of RNAs is becoming important, since the discovery of functional non-coding RNAs (ncRNAs. Recent studies, mainly based on various approximations of the Sankoff algorithm, have resulted in considerable improvement in the accuracy of pairwise structural alignment. In contrast, for the cases with more than two sequences, the practical merit of structural alignment remains unclear as compared to traditional sequence-based methods, although the importance of multiple structural alignment is widely recognized. Results We took a different approach from a straightforward extension of the Sankoff algorithm to the multiple alignments from the viewpoints of accuracy and time complexity. As a new option of the MAFFT alignment program, we developed a multiple RNA alignment framework, X-INS-i, which builds a multiple alignment with an iterative method incorporating structural information through two components: (1 pairwise structural alignments by an external pairwise alignment method such as SCARNA or LaRA and (2 a new objective function, Four-way Consistency, derived from the base-pairing probability of every sub-aligned group at every multiple alignment stage. Conclusion The BRAliBASE benchmark showed that X-INS-i outperforms other methods currently available in the sum-of-pairs score (SPS criterion. As a basis for predicting common secondary structure, the accuracy of the present method is comparable to or rather higher than those of the current leading methods such as RNA Sampler. The X-INS-i framework can be used for building a multiple RNA alignment from any combination of algorithms for pairwise RNA alignment and base-pairing probability. The source code is available at the webpage found in the Availability and requirements section.

  8. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez and Y. Pakhotin

    2012-01-01

      A new track-based alignment for the DT chambers is ready for deployment: an offline tag has already been produced which will become part of the 52X Global Tag. This alignment was validated within the muon alignment group both at low and high momentum using a W/Z skim sample. It shows an improved mass resolution for pairs of stand-alone muons, improved curvature resolution at high momentum, and improved DT segment extrapolation residuals. The validation workflow for high-momentum muons used to depend solely on the “split cosmics” method, looking at the curvature difference between muon tracks reconstructed in the upper or lower half of CMS. The validation has now been extended to include energetic muons decaying from heavily boosted Zs: the di-muon invariant mass for global and stand-alone muons is reconstructed, and the invariant mass resolution is compared for different alignments. The main areas of development over the next few months will be preparing a new track-based C...

  9. Use of DNA markers in forest tree improvement research

    Science.gov (United States)

    D.B. Neale; M.E. Devey; K.D. Jermstad; M.R. Ahuja; M.C. Alosi; K.A. Marshall

    1992-01-01

    DNA markers are rapidly being developed for forest trees. The most important markers are restriction fragment length polymorphisms (RFLPs), polymerase chain reaction- (PCR) based markers such as random amplified polymorphic DNA (RAPD), and fingerprinting markers. DNA markers can supplement isozyme markers for monitoring tree improvement activities such as; estimating...

  10. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    Z. Szillasi and G. Gomez.

    2013-01-01

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

  11. TCS: a new multiple sequence alignment reliability measure to estimate alignment accuracy and improve phylogenetic tree reconstruction.

    Science.gov (United States)

    Chang, Jia-Ming; Di Tommaso, Paolo; Notredame, Cedric

    2014-06-01

    Multiple sequence alignment (MSA) is a key modeling procedure when analyzing biological sequences. Homology and evolutionary modeling are the most common applications of MSAs. Both are known to be sensitive to the underlying MSA accuracy. In this work, we show how this problem can be partly overcome using the transitive consistency score (TCS), an extended version of the T-Coffee scoring scheme. Using this local evaluation function, we show that one can identify the most reliable portions of an MSA, as judged from BAliBASE and PREFAB structure-based reference alignments. We also show how this measure can be used to improve phylogenetic tree reconstruction using both an established simulated data set and a novel empirical yeast data set. For this purpose, we describe a novel lossless alternative to site filtering that involves overweighting the trustworthy columns. Our approach relies on the T-Coffee framework; it uses libraries of pairwise alignments to evaluate any third party MSA. Pairwise projections can be produced using fast or slow methods, thus allowing a trade-off between speed and accuracy. We compared TCS with Heads-or-Tails, GUIDANCE, Gblocks, and trimAl and found it to lead to significantly better estimates of structural accuracy and more accurate phylogenetic trees. The software is available from www.tcoffee.org/Projects/tcs. © The Author 2014. Published by Oxford University Press on behalf of the Society for Molecular Biology and Evolution. All rights reserved. For permissions, please e-mail: journals.permissions@oup.com.

  12. Improving alignment in Tract-based spatial statistics: evaluation and optimization of image registration

    NARCIS (Netherlands)

    de Groot, Marius; Vernooij, Meike W.; Klein, Stefan; Ikram, M. Arfan; Vos, Frans M.; Smith, Stephen M.; Niessen, Wiro J.; Andersson, Jesper L. R.

    2013-01-01

    Anatomical alignment in neuroimaging studies is of such importance that considerable effort is put into improving the registration used to establish spatial correspondence. Tract-based spatial statistics (TBSS) is a popular method for comparing diffusion characteristics across subjects. TBSS

  13. Improving alignment in Tract-based spatial statistics : Evaluation and optimization of image registration

    NARCIS (Netherlands)

    De Groot, M.; Vernooij, M.W.; Klein, S.; Arfan Ikram, M.; Vos, F.M.; Smith, S.M.; Niessen, W.J.; Andersson, J.L.R.

    2013-01-01

    Anatomical alignment in neuroimaging studies is of such importance that considerable effort is put into improving the registration used to establish spatial correspondence. Tract-based spatial statistics (TBSS) is a popular method for comparing diffusion characteristics across subjects. TBSS

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

    Directory of Open Access Journals (Sweden)

    Kim Taeho

    2010-09-01

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

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

    Directory of Open Access Journals (Sweden)

    Daniels Noah M

    2012-10-01

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

  16. Computer navigation experience in hip resurfacing improves femoral component alignment using a conventional jig

    Directory of Open Access Journals (Sweden)

    Zachary Morison

    2013-01-01

    Full Text Available Background:The use of computer navigation has been shown to improve the accuracy of femoral component placement compared to conventional instrumentation in hip resurfacing. Whether exposure to computer navigation improves accuracy when the procedure is subsequently performed with conventional instrumentation without navigation has not been explored. We examined whether femoral component alignment utilizing a conventional jig improves following experience with the use of imageless computer navigation for hip resurfacing. Materials and Methods:Between December 2004 and December 2008, 213 consecutive hip resurfacings were performed by a single surgeon. The first 17 (Cohort 1 and the last 9 (Cohort 2 hip resurfacings were performed using a conventional guidewire alignment jig. In 187 cases, the femoral component was implanted using the imageless computer navigation. Cohorts 1 and 2 were compared for femoral component alignment accuracy. Results:All components in Cohort 2 achieved the position determined by the preoperative plan. The mean deviation of the stem-shaft angle (SSA from the preoperatively planned target position was 2.2° in Cohort 2 and 5.6° in Cohort 1 ( P = 0.01. Four implants in Cohort 1 were positioned at least 10° varus compared to the target SSA position and another four were retroverted. Conclusions: Femoral component placement utilizing conventional instrumentation may be more accurate following experience using imageless computer navigation.

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

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

  19. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez

    2010-01-01

    For the last three months, the Muon Alignment group has focussed on providing a new, improved set of alignment constants for the end-of-year data reprocessing. These constants were delivered on time and approved by the CMS physics validation team on November 17. The new alignment incorporates several improvements over the previous one from March for nearly all sub-systems. Motivated by the loss of information from a hardware failure in May (an entire MAB was lost), the optical barrel alignment has moved from a modular, super-plane reconstruction, to a full, single loop calculation of the entire geometry for all DTs in stations 1, 2 and 3. This makes better use of the system redundancy, mitigating the effect of the information loss. Station 4 is factorised and added afterwards to make the system smaller (and therefore faster to run), and also because the MAB calibration at the MB4 zone is less precise. This new alignment procedure was tested at 0 T against photogrammetry resulting in precisions of the order...

  20. GATA: A graphic alignment tool for comparative sequenceanalysis

    Energy Technology Data Exchange (ETDEWEB)

    Nix, David A.; Eisen, Michael B.

    2005-01-01

    Several problems exist with current methods used to align DNA sequences for comparative sequence analysis. Most dynamic programming algorithms assume that conserved sequence elements are collinear. This assumption appears valid when comparing orthologous protein coding sequences. Functional constraints on proteins provide strong selective pressure against sequence inversions, and minimize sequence duplications and feature shuffling. For non-coding sequences this collinearity assumption is often invalid. For example, enhancers contain clusters of transcription factor binding sites that change in number, orientation, and spacing during evolution yet the enhancer retains its activity. Dotplot analysis is often used to estimate non-coding sequence relatedness. Yet dot plots do not actually align sequences and thus cannot account well for base insertions or deletions. Moreover, they lack an adequate statistical framework for comparing sequence relatedness and are limited to pairwise comparisons. Lastly, dot plots and dynamic programming text outputs fail to provide an intuitive means for visualizing DNA alignments.

  1. DNA Camouflage

    Science.gov (United States)

    2016-01-08

    1 DNA Camouflage Supplementary Information Bijan Zakeri1,2*, Timothy K. Lu1,2*, Peter A. Carr2,3* 1Department of Electrical Engineering and...ll.mit.edu). Distribution A: Public Release   2 Supplementary Figure 1 DNA camouflage with the 2-state device. (a) In the presence of Cre, DSD-2[α...10 1 + Cre 1 500 1,000 length (bp) chromatogram alignment template − Cre   4 Supplementary Figure 3 DNA camouflage with a switchable

  2. Carbon nanotube-incorporated collagen hydrogels improve cell alignment and the performance of cardiac constructs

    Directory of Open Access Journals (Sweden)

    Sun HY

    2017-04-01

    Full Text Available Hongyu Sun,* Jing Zhou,* Zhu Huang,* Linlin Qu,* Ning Lin,* Chengxiao Liang, Ruiwu Dai, Lijun Tang, Fuzhou Tian General Surgery Center, Chengdu Military General Hospital, Chengdu, China *These authors contributed equally to this work Abstract: Carbon nanotubes (CNTs provide an essential 2-D microenvironment for cardiomyocyte growth and function. However, it remains to be elucidated whether CNT nanostructures can promote cell–cell integrity and facilitate the formation of functional tissues in 3-D hydrogels. Here, single-walled CNTs were incorporated into collagen hydrogels to fabricate (CNT/Col hydrogels, which improved mechanical and electrical properties. The incorporation of CNTs (up to 1 wt% exhibited no toxicity to cardiomyocytes and enhanced cell adhesion and elongation. Through the use of immunohistochemical staining, transmission electron microscopy, and intracellular calcium-transient measurement, the incorporation of CNTs was found to improve cell alignment and assembly remarkably, which led to the formation of engineered cardiac tissues with stronger contraction potential. Importantly, cardiac tissues based on CNT/Col hydrogels were noted to have better functionality. Collectively, the incorporation of CNTs into the Col hydrogels improved cell alignment and the performance of cardiac constructs. Our study suggests that CNT/Col hydrogels offer a promising tissue scaffold for cardiac constructs, and might serve as injectable biomaterials to deliver cell or drug molecules for cardiac regeneration following myocardial infarction in the near future. Keywords: carbon nanotubes, collagen hydrogel, cardiac constructs, cell alignment, tissue functionality

  3. Ancestral sequence alignment under optimal conditions

    Directory of Open Access Journals (Sweden)

    Brown Daniel G

    2005-11-01

    Full Text Available Abstract Background Multiple genome alignment is an important problem in bioinformatics. An important subproblem used by many multiple alignment approaches is that of aligning two multiple alignments. Many popular alignment algorithms for DNA use the sum-of-pairs heuristic, where the score of a multiple alignment is the sum of its induced pairwise alignment scores. However, the biological meaning of the sum-of-pairs of pairs heuristic is not obvious. Additionally, many algorithms based on the sum-of-pairs heuristic are complicated and slow, compared to pairwise alignment algorithms. An alternative approach to aligning alignments is to first infer ancestral sequences for each alignment, and then align the two ancestral sequences. In addition to being fast, this method has a clear biological basis that takes into account the evolution implied by an underlying phylogenetic tree. In this study we explore the accuracy of aligning alignments by ancestral sequence alignment. We examine the use of both maximum likelihood and parsimony to infer ancestral sequences. Additionally, we investigate the effect on accuracy of allowing ambiguity in our ancestral sequences. Results We use synthetic sequence data that we generate by simulating evolution on a phylogenetic tree. We use two different types of phylogenetic trees: trees with a period of rapid growth followed by a period of slow growth, and trees with a period of slow growth followed by a period of rapid growth. We examine the alignment accuracy of four ancestral sequence reconstruction and alignment methods: parsimony, maximum likelihood, ambiguous parsimony, and ambiguous maximum likelihood. Additionally, we compare against the alignment accuracy of two sum-of-pairs algorithms: ClustalW and the heuristic of Ma, Zhang, and Wang. Conclusion We find that allowing ambiguity in ancestral sequences does not lead to better multiple alignments. Regardless of whether we use parsimony or maximum likelihood, the

  4. Alignment and prediction of cis-regulatory modules based on a probabilistic model of evolution.

    Directory of Open Access Journals (Sweden)

    Xin He

    2009-03-01

    Full Text Available Cross-species comparison has emerged as a powerful paradigm for predicting cis-regulatory modules (CRMs and understanding their evolution. The comparison requires reliable sequence alignment, which remains a challenging task for less conserved noncoding sequences. Furthermore, the existing models of DNA sequence evolution generally do not explicitly treat the special properties of CRM sequences. To address these limitations, we propose a model of CRM evolution that captures different modes of evolution of functional transcription factor binding sites (TFBSs and the background sequences. A particularly novel aspect of our work is a probabilistic model of gains and losses of TFBSs, a process being recognized as an important part of regulatory sequence evolution. We present a computational framework that uses this model to solve the problems of CRM alignment and prediction. Our alignment method is similar to existing methods of statistical alignment but uses the conserved binding sites to improve alignment. Our CRM prediction method deals with the inherent uncertainties of binding site annotations and sequence alignment in a probabilistic framework. In simulated as well as real data, we demonstrate that our program is able to improve both alignment and prediction of CRM sequences over several state-of-the-art methods. Finally, we used alignments produced by our program to study binding site conservation in genome-wide binding data of key transcription factors in the Drosophila blastoderm, with two intriguing results: (i the factor-bound sequences are under strong evolutionary constraints even if their neighboring genes are not expressed in the blastoderm and (ii binding sites in distal bound sequences (relative to transcription start sites tend to be more conserved than those in proximal regions. Our approach is implemented as software, EMMA (Evolutionary Model-based cis-regulatory Module Analysis, ready to be applied in a broad biological context.

  5. Model selection in Bayesian segmentation of multiple DNA alignments.

    Science.gov (United States)

    Oldmeadow, Christopher; Keith, Jonathan M

    2011-03-01

    The analysis of multiple sequence alignments is allowing researchers to glean valuable insights into evolution, as well as identify genomic regions that may be functional, or discover novel classes of functional elements. Understanding the distribution of conservation levels that constitutes the evolutionary landscape is crucial to distinguishing functional regions from non-functional. Recent evidence suggests that a binary classification of evolutionary rates is inappropriate for this purpose and finds only highly conserved functional elements. Given that the distribution of evolutionary rates is multi-modal, determining the number of modes is of paramount concern. Through simulation, we evaluate the performance of a number of information criterion approaches derived from MCMC simulations in determining the dimension of a model. We utilize a deviance information criterion (DIC) approximation that is more robust than the approximations from other information criteria, and show our information criteria approximations do not produce superfluous modes when estimating conservation distributions under a variety of circumstances. We analyse the distribution of conservation for a multiple alignment comprising four primate species and mouse, and repeat this on two additional multiple alignments of similar species. We find evidence of six distinct classes of evolutionary rates that appear to be robust to the species used. Source code and data are available at http://dl.dropbox.com/u/477240/changept.zip.

  6. Optimization of sequence alignment for simple sequence repeat regions

    Directory of Open Access Journals (Sweden)

    Ogbonnaya Francis C

    2011-07-01

    Full Text Available Abstract Background Microsatellites, or simple sequence repeats (SSRs, are tandemly repeated DNA sequences, including tandem copies of specific sequences no longer than six bases, that are distributed in the genome. SSR has been used as a molecular marker because it is easy to detect and is used in a range of applications, including genetic diversity, genome mapping, and marker assisted selection. It is also very mutable because of slipping in the DNA polymerase during DNA replication. This unique mutation increases the insertion/deletion (INDELs mutation frequency to a high ratio - more than other types of molecular markers such as single nucleotide polymorphism (SNPs. SNPs are more frequent than INDELs. Therefore, all designed algorithms for sequence alignment fit the vast majority of the genomic sequence without considering microsatellite regions, as unique sequences that require special consideration. The old algorithm is limited in its application because there are many overlaps between different repeat units which result in false evolutionary relationships. Findings To overcome the limitation of the aligning algorithm when dealing with SSR loci, a new algorithm was developed using PERL script with a Tk graphical interface. This program is based on aligning sequences after determining the repeated units first, and the last SSR nucleotides positions. This results in a shifting process according to the inserted repeated unit type. When studying the phylogenic relations before and after applying the new algorithm, many differences in the trees were obtained by increasing the SSR length and complexity. However, less distance between different linage had been observed after applying the new algorithm. Conclusions The new algorithm produces better estimates for aligning SSR loci because it reflects more reliable evolutionary relations between different linages. It reduces overlapping during SSR alignment, which results in a more realistic

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

    Directory of Open Access Journals (Sweden)

    Nils Homer

    2009-11-01

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

  8. An improved model for whole genome phylogenetic analysis by Fourier transform.

    Science.gov (United States)

    Yin, Changchuan; Yau, Stephen S-T

    2015-10-07

    DNA sequence similarity comparison is one of the major steps in computational phylogenetic studies. The sequence comparison of closely related DNA sequences and genomes is usually performed by multiple sequence alignments (MSA). While the MSA method is accurate for some types of sequences, it may produce incorrect results when DNA sequences undergone rearrangements as in many bacterial and viral genomes. It is also limited by its computational complexity for comparing large volumes of data. Previously, we proposed an alignment-free method that exploits the full information contents of DNA sequences by Discrete Fourier Transform (DFT), but still with some limitations. Here, we present a significantly improved method for the similarity comparison of DNA sequences by DFT. In this method, we map DNA sequences into 2-dimensional (2D) numerical sequences and then apply DFT to transform the 2D numerical sequences into frequency domain. In the 2D mapping, the nucleotide composition of a DNA sequence is a determinant factor and the 2D mapping reduces the nucleotide composition bias in distance measure, and thus improving the similarity measure of DNA sequences. To compare the DFT power spectra of DNA sequences with different lengths, we propose an improved even scaling algorithm to extend shorter DFT power spectra to the longest length of the underlying sequences. After the DFT power spectra are evenly scaled, the spectra are in the same dimensionality of the Fourier frequency space, then the Euclidean distances of full Fourier power spectra of the DNA sequences are used as the dissimilarity metrics. The improved DFT method, with increased computational performance by 2D numerical representation, can be applicable to any DNA sequences of different length ranges. We assess the accuracy of the improved DFT similarity measure in hierarchical clustering of different DNA sequences including simulated and real datasets. The method yields accurate and reliable phylogenetic trees

  9. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    S. Szillasi

    2013-01-01

    The CMS detector has been gradually opened and whenever a wheel became exposed the first operation was the removal of the MABs, the sensor structures of the Hardware Barrel Alignment System. By the last days of June all 36 MABs have arrived at the Alignment Lab at the ISR where, as part of the Alignment Upgrade Project, they are refurbished with new Survey target holders. Their electronic checkout is on the way and finally they will be recalibrated. During LS1 the alignment system will be upgraded in order to allow more precise reconstruction of the MB4 chambers in Sector 10 and Sector 4. This requires new sensor components, so called MiniMABs (pictured below), that have already been assembled and calibrated. Image 6: Calibrated MiniMABs are ready for installation For the track-based alignment, the systematic uncertainties of the algorithm are under scrutiny: this study will enable the production of an improved Monte Carlo misalignment scenario and to update alignment position errors eventually, crucial...

  10. Beyond clinical engagement: a pragmatic model for quality improvement interventions, aligning clinical and managerial priorities.

    Science.gov (United States)

    Pannick, Samuel; Sevdalis, Nick; Athanasiou, Thanos

    2016-09-01

    Despite taking advantage of established learning from other industries, quality improvement initiatives in healthcare may struggle to outperform secular trends. The reasons for this are rarely explored in detail, and are often attributed merely to difficulties in engaging clinicians in quality improvement work. In a narrative review of the literature, we argue that this focus on clinicians, at the relative expense of managerial staff, has proven counterproductive. Clinical engagement is not a universal challenge; moreover, there is evidence that managers-particularly middle managers-also have a role to play in quality improvement. Yet managerial participation in quality improvement interventions is often assumed, rather than proven. We identify specific factors that influence the coordination of front-line staff and managers in quality improvement, and integrate these factors into a novel model: the model of alignment. We use this model to explore the implementation of an interdisciplinary intervention in a recent trial, describing different participation incentives and barriers for different staff groups. The extent to which clinical and managerial interests align may be an important determinant of the ultimate success of quality improvement interventions. Published by the BMJ Publishing Group Limited. For permission to use (where not already granted under a licence) please go to http://www.bmj.com/company/products-services/rights-and-licensing/

  11. Improved image alignment method in application to X-ray images and biological images.

    Science.gov (United States)

    Wang, Ching-Wei; Chen, Hsiang-Chou

    2013-08-01

    Alignment of medical images is a vital component of a large number of applications throughout the clinical track of events; not only within clinical diagnostic settings, but prominently so in the area of planning, consummation and evaluation of surgical and radiotherapeutical procedures. However, image registration of medical images is challenging because of variations on data appearance, imaging artifacts and complex data deformation problems. Hence, the aim of this study is to develop a robust image alignment method for medical images. An improved image registration method is proposed, and the method is evaluated with two types of medical data, including biological microscopic tissue images and dental X-ray images and compared with five state-of-the-art image registration techniques. The experimental results show that the presented method consistently performs well on both types of medical images, achieving 88.44 and 88.93% averaged registration accuracies for biological tissue images and X-ray images, respectively, and outperforms the benchmark methods. Based on the Tukey's honestly significant difference test and Fisher's least square difference test tests, the presented method performs significantly better than all existing methods (P ≤ 0.001) for tissue image alignment, and for the X-ray image registration, the proposed method performs significantly better than the two benchmark b-spline approaches (P < 0.001). The software implementation of the presented method and the data used in this study are made publicly available for scientific communities to use (http://www-o.ntust.edu.tw/∼cweiwang/ImprovedImageRegistration/). cweiwang@mail.ntust.edu.tw.

  12. Fast discovery and visualization of conserved regions in DNA sequences using quasi-alignment.

    Science.gov (United States)

    Nagar, Anurag; Hahsler, Michael

    2013-01-01

    Next Generation Sequencing techniques are producing enormous amounts of biological sequence data and analysis becomes a major computational problem. Currently, most analysis, especially the identification of conserved regions, relies heavily on Multiple Sequence Alignment and its various heuristics such as progressive alignment, whose run time grows with the square of the number and the length of the aligned sequences and requires significant computational resources. In this work, we present a method to efficiently discover regions of high similarity across multiple sequences without performing expensive sequence alignment. The method is based on approximating edit distance between segments of sequences using p-mer frequency counts. Then, efficient high-throughput data stream clustering is used to group highly similar segments into so called quasi-alignments. Quasi-alignments have numerous applications such as identifying species and their taxonomic class from sequences, comparing sequences for similarities, and, as in this paper, discovering conserved regions across related sequences. In this paper, we show that quasi-alignments can be used to discover highly similar segments across multiple sequences from related or different genomes efficiently and accurately. Experiments on a large number of unaligned 16S rRNA sequences obtained from the Greengenes database show that the method is able to identify conserved regions which agree with known hypervariable regions in 16S rRNA. Furthermore, the experiments show that the proposed method scales well for large data sets with a run time that grows only linearly with the number and length of sequences, whereas for existing multiple sequence alignment heuristics the run time grows super-linearly. Quasi-alignment-based algorithms can detect highly similar regions and conserved areas across multiple sequences. Since the run time is linear and the sequences are converted into a compact clustering model, we are able to

  13. Carbon nanotube-incorporated collagen hydrogels improve cell alignment and the performance of cardiac constructs

    Science.gov (United States)

    Sun, Hongyu; Zhou, Jing; Huang, Zhu; Qu, Linlin; Lin, Ning; Liang, Chengxiao; Dai, Ruiwu; Tang, Lijun; Tian, Fuzhou

    2017-01-01

    Carbon nanotubes (CNTs) provide an essential 2-D microenvironment for cardiomyocyte growth and function. However, it remains to be elucidated whether CNT nanostructures can promote cell–cell integrity and facilitate the formation of functional tissues in 3-D hydrogels. Here, single-walled CNTs were incorporated into collagen hydrogels to fabricate (CNT/Col) hydrogels, which improved mechanical and electrical properties. The incorporation of CNTs (up to 1 wt%) exhibited no toxicity to cardiomyocytes and enhanced cell adhesion and elongation. Through the use of immunohistochemical staining, transmission electron microscopy, and intracellular calcium-transient measurement, the incorporation of CNTs was found to improve cell alignment and assembly remarkably, which led to the formation of engineered cardiac tissues with stronger contraction potential. Importantly, cardiac tissues based on CNT/Col hydrogels were noted to have better functionality. Collectively, the incorporation of CNTs into the Col hydrogels improved cell alignment and the performance of cardiac constructs. Our study suggests that CNT/Col hydrogels offer a promising tissue scaffold for cardiac constructs, and might serve as injectable biomaterials to deliver cell or drug molecules for cardiac regeneration following myocardial infarction in the near future. PMID:28450785

  14. Membranes having aligned 1-D nanoparticles in a matrix layer for improved fluid separation

    Science.gov (United States)

    Revanur, Ravindra; Lulevich, Valentin; Roh, Il Juhn; Klare, Jennifer E.; Kim, Sangil; Noy, Aleksandr; Bakajin, Olgica

    2015-12-22

    Membranes for fluid separation are disclosed. These membranes have a matrix layer sandwiched between an active layer and a porous support layer. The matrix layer includes 1-D nanoparticles that are vertically aligned in a porous polymer matrix, and which substantially extend through the matrix layer. The active layer provides species-specific transport, while the support layer provides mechanical support. A matrix layer of this type has favorable surface morphology for forming the active layer. Furthermore, the pores that form in the matrix layer tend to be smaller and more evenly distributed as a result of the presence of aligned 1-D nanoparticles. Improved performance of separation membranes of this type is attributed to these effects.

  15. Improvement of Synthetic Biology Tools for DNA Editing

    DEFF Research Database (Denmark)

    Cavaleiro, Mafalda

    with the development and improvement of DNA editing strategies,compatible with other DNA assembly methodologies, genome engineering and,eventually, automation processes. Expanding and optimizing the synbio toolkit has important applications in pathway optimization for metabolic engineering, design and characterization...... of gene circuits, synthesis of whole genomes and natural product discovery. In line with this, it is also described in this thesis how discovery of new cytochromes P450 (CYPs) from marine bacteria could benefit industrial processes....

  16. How effective are DNA barcodes in the identification of African rainforest trees?

    Science.gov (United States)

    Parmentier, Ingrid; Duminil, Jérôme; Kuzmina, Maria; Philippe, Morgane; Thomas, Duncan W; Kenfack, David; Chuyong, George B; Cruaud, Corinne; Hardy, Olivier J

    2013-01-01

    DNA barcoding of rain forest trees could potentially help biologists identify species and discover new ones. However, DNA barcodes cannot always distinguish between closely related species, and the size and completeness of barcode databases are key parameters for their successful application. We test the ability of rbcL, matK and trnH-psbA plastid DNA markers to identify rain forest trees at two sites in Atlantic central Africa under the assumption that a database is exhaustive in terms of species content, but not necessarily in terms of haplotype diversity within species. We assess the accuracy of identification to species or genus using a genetic distance matrix between samples either based on a global multiple sequence alignment (GD) or on a basic local alignment search tool (BLAST). Where a local database is available (within a 50 ha plot), barcoding was generally reliable for genus identification (95-100% success), but less for species identification (71-88%). Using a single marker, best results for species identification were obtained with trnH-psbA. There was a significant decrease of barcoding success in species-rich clades. When the local database was used to identify the genus of trees from another region and did include all genera from the query individuals but not all species, genus identification success decreased to 84-90%. The GD method performed best but a global multiple sequence alignment is not applicable on trnH-psbA. Barcoding is a useful tool to assign unidentified African rain forest trees to a genus, but identification to a species is less reliable, especially in species-rich clades, even using an exhaustive local database. Combining two markers improves the accuracy of species identification but it would only marginally improve genus identification. Finally, we highlight some limitations of the BLAST algorithm as currently implemented and suggest possible improvements for barcoding applications.

  17. Sequence analysis of Leukemia DNA

    Science.gov (United States)

    Nacong, Nasria; Lusiyanti, Desy; Irawan, Muhammad. Isa

    2018-03-01

    Cancer is a very deadly disease, one of which is leukemia disease or better known as blood cancer. The cancer cell can be detected by taking DNA in laboratory test. This study focused on local alignment of leukemia and non leukemia data resulting from NCBI in the form of DNA sequences by using Smith-Waterman algorithm. SmithWaterman algorithm was invented by TF Smith and MS Waterman in 1981. These algorithms try to find as much as possible similarity of a pair of sequences, by giving a negative value to the unequal base pair (mismatch), and positive values on the same base pair (match). So that will obtain the maximum positive value as the end of the alignment, and the minimum value as the initial alignment. This study will use sequences of leukemia and 3 sequences of non leukemia.

  18. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    M. Dallavalle

    2013-01-01

    A new Muon misalignment scenario for 2011 (7 TeV) Monte Carlo re-processing was re-leased. The scenario is based on running of standard track-based reference-target algorithm (exactly as in data) using single-muon simulated sample (with the transverse-momentum spectrum matching data). It used statistics similar to what was used for alignment with 2011 data, starting from an initially misaligned Muon geometry from uncertainties of hardware measurements and using the latest Tracker misalignment geometry. Validation of the scenario (with muons from Z decay and high-pT simulated muons) shows that it describes data well. The study of systematic uncertainties (dominant by now due to huge amount of data collected by CMS and used for muon alignment) is finalised. Realistic alignment position errors are being obtained from the estimated uncertainties and are expected to improve the muon reconstruction performance. Concerning the Hardware Alignment System, the upgrade of the Barrel Alignment is in progress. By now, d...

  19. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez

    2011-01-01

    A new set of muon alignment constants was approved in August. The relative position between muon chambers is essentially unchanged, indicating good detector stability. The main changes concern the global positioning of the barrel and of the endcap rings to match the new Tracker geometry. Detailed studies of the differences between track-based and optical alignment of DTs have proven to be a valuable tool for constraining Tracker alignment weak modes, and this information is now being used as part of the alignment procedure. In addition to the “split-cosmic” analysis used to investigate the muon momentum resolution at high momentum, a new procedure based on reconstructing the invariant mass of di-muons from boosted Zs is under development. Both procedures show an improvement in the momentum precision of Global Muons with respect to Tracker-only Muons. Recent developments in track-based alignment include a better treatment of the tails of residual distributions and accounting for correla...

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

    Directory of Open Access Journals (Sweden)

    Schirmer Stefanie

    2010-04-01

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

  1. Protein alignment algorithms with an efficient backtracking routine on multiple GPUs

    Directory of Open Access Journals (Sweden)

    Kierzynka Michal

    2011-05-01

    Full Text Available Abstract Background Pairwise sequence alignment methods are widely used in biological research. The increasing number of sequences is perceived as one of the upcoming challenges for sequence alignment methods in the nearest future. To overcome this challenge several GPU (Graphics Processing Unit computing approaches have been proposed lately. These solutions show a great potential of a GPU platform but in most cases address the problem of sequence database scanning and computing only the alignment score whereas the alignment itself is omitted. Thus, the need arose to implement the global and semiglobal Needleman-Wunsch, and Smith-Waterman algorithms with a backtracking procedure which is needed to construct the alignment. Results In this paper we present the solution that performs the alignment of every given sequence pair, which is a required step for progressive multiple sequence alignment methods, as well as for DNA recognition at the DNA assembly stage. Performed tests show that the implementation, with performance up to 6.3 GCUPS on a single GPU for affine gap penalties, is very efficient in comparison to other CPU and GPU-based solutions. Moreover, multiple GPUs support with load balancing makes the application very scalable. Conclusions The article shows that the backtracking procedure of the sequence alignment algorithms may be designed to fit in with the GPU architecture. Therefore, our algorithm, apart from scores, is able to compute pairwise alignments. This opens a wide range of new possibilities, allowing other methods from the area of molecular biology to take advantage of the new computational architecture. Performed tests show that the efficiency of the implementation is excellent. Moreover, the speed of our GPU-based algorithms can be almost linearly increased when using more than one graphics card.

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

    Science.gov (United States)

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

    2014-01-01

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

  3. Improved DNA clamps by stacking to adjacent nucleobases

    DEFF Research Database (Denmark)

    Fatthalla, M.I.; Pedersen, Erik Bjerregaard

    2012-01-01

    Three or four aromatic rings interconnected by acetylene bridges form a stiff conjugated system with sufficient conformational freedom to make it useful to link together the two strands of a DNA clamp. Upon targeting a ssDNA, the conformational flexibility allows better stacking of the linker...... to the underlying non-planar base triplet in the formed triplex. This type of triplexes has a substantially higher thermal melting temperature which can be further improved by inserting locked nucleic acids (LNAs) in the Hoogsteen part of the clamp. An extremely high sensitivity to mismatches is observed...

  4. Vertically aligned carbon nanotubes/diamond double-layered structure for improved field electron emission stability

    Energy Technology Data Exchange (ETDEWEB)

    Yang, L., E-mail: qiaoqin.yang@mail.usask.ca; Yang, Q.; Zhang, C.; Li, Y.S.

    2013-12-31

    A double-layered nanostructure consisting of a layer of vertically aligned Carbon Nanotubes (CNTs) and a layer of diamond beneath has been synthesized on silicon substrate by Hot Filament Chemical Vapor Deposition. The synthesis was achieved by first depositing a layer of diamond on silicon and then depositing a top layer of vertically aligned CNTs by applying a negative bias on the substrate holder. The growth of CNTs was catalyzed by a thin layer of spin-coated iron nitride. The surface morphology and structure of the CNTs/diamond double-layered structure were characterized by Scanning Electron Microscope, Energy Dispersive X-ray spectrum, and Raman Spectroscopy. Their field electron emission (FEE) properties were measured by KEITHLEY 237 high voltage measurement unit, showing much higher FEE current stability than single layered CNTs. - Highlights: • A new double-layered nanostructure consisting of a layer of vertically aligned CNTs and a layer of diamond beneath has been synthesized by hot filament chemical vapor deposition. • This double-layered structure exhibits superior field electron emission stability. • The improvement of emission stability is due to the combination of the unique properties of diamond and CNTs.

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

    Science.gov (United States)

    Menges, Fabian; Narzisi, Giuseppe; Mishra, Bud

    2011-09-01

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

  6. Kinetics of DNA tile dimerization.

    Science.gov (United States)

    Jiang, Shuoxing; Yan, Hao; Liu, Yan

    2014-06-24

    Investigating how individual molecular components interact with one another within DNA nanoarchitectures, both in terms of their spatial and temporal interactions, is fundamentally important for a better understanding of their physical behaviors. This will provide researchers with valuable insight for designing more complex higher-order structures that can be assembled more efficiently. In this report, we examined several spatial factors that affect the kinetics of bivalent, double-helical (DH) tile dimerization, including the orientation and number of sticky ends (SEs), the flexibility of the double helical domains, and the size of the tiles. The rate constants we obtained confirm our hypothesis that increased nucleation opportunities and well-aligned SEs accelerate tile-tile dimerization. Increased flexibility in the tiles causes slower dimerization rates, an effect that can be reversed by introducing restrictions to the tile flexibility. The higher dimerization rates of more rigid tiles results from the opposing effects of higher activation energies and higher pre-exponential factors from the Arrhenius equation, where the pre-exponential factor dominates. We believe that the results presented here will assist in improved implementation of DNA tile based algorithmic self-assembly, DNA based molecular robotics, and other specific nucleic acid systems, and will provide guidance to design and assembly processes to improve overall yield and efficiency.

  7. A Clustal Alignment Improver Using Evolutionary Algorithms

    DEFF Research Database (Denmark)

    Thomsen, Rene; Fogel, Gary B.; Krink, Thimo

    2002-01-01

    Multiple sequence alignment (MSA) is a crucial task in bioinformatics. In this paper we extended previous work with evolutionary algorithms (EA) by using MSA solutions obtained from the wellknown Clustal V algorithm as a candidate solution seed of the initial EA population. Our results clearly show...

  8. DNA nanotubes for NMR structure determination of membrane proteins.

    Science.gov (United States)

    Bellot, Gaëtan; McClintock, Mark A; Chou, James J; Shih, William M

    2013-04-01

    Finding a way to determine the structures of integral membrane proteins using solution nuclear magnetic resonance (NMR) spectroscopy has proved to be challenging. A residual-dipolar-coupling-based refinement approach can be used to resolve the structure of membrane proteins up to 40 kDa in size, but to do this you need a weak-alignment medium that is detergent-resistant and it has thus far been difficult to obtain such a medium suitable for weak alignment of membrane proteins. We describe here a protocol for robust, large-scale synthesis of detergent-resistant DNA nanotubes that can be assembled into dilute liquid crystals for application as weak-alignment media in solution NMR structure determination of membrane proteins in detergent micelles. The DNA nanotubes are heterodimers of 400-nm-long six-helix bundles, each self-assembled from a M13-based p7308 scaffold strand and >170 short oligonucleotide staple strands. Compatibility with proteins bearing considerable positive charge as well as modulation of molecular alignment, toward collection of linearly independent restraints, can be introduced by reducing the negative charge of DNA nanotubes using counter ions and small DNA-binding molecules. This detergent-resistant liquid-crystal medium offers a number of properties conducive for membrane protein alignment, including high-yield production, thermal stability, buffer compatibility and structural programmability. Production of sufficient nanotubes for four or five NMR experiments can be completed in 1 week by a single individual.

  9. FEAST: sensitive local alignment with multiple rates of evolution.

    Science.gov (United States)

    Hudek, Alexander K; Brown, Daniel G

    2011-01-01

    We present a pairwise local aligner, FEAST, which uses two new techniques: a sensitive extension algorithm for identifying homologous subsequences, and a descriptive probabilistic alignment model. We also present a new procedure for training alignment parameters and apply it to the human and mouse genomes, producing a better parameter set for these sequences. Our extension algorithm identifies homologous subsequences by considering all evolutionary histories. It has higher maximum sensitivity than Viterbi extensions, and better balances specificity. We model alignments with several submodels, each with unique statistical properties, describing strongly similar and weakly similar regions of homologous DNA. Training parameters using two submodels produces superior alignments, even when we align with only the parameters from the weaker submodel. Our extension algorithm combined with our new parameter set achieves sensitivity 0.59 on synthetic tests. In contrast, LASTZ with default settings achieves sensitivity 0.35 with the same false positive rate. Using the weak submodel as parameters for LASTZ increases its sensitivity to 0.59 with high error. FEAST is available at http://monod.uwaterloo.ca/feast/.

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

    Directory of Open Access Journals (Sweden)

    Lefkowitz Elliot J

    2005-08-01

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

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

    Science.gov (United States)

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

    2012-01-01

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

  12. Environmental DNA (eDNA sampling improves occurrence and detection estimates of invasive burmese pythons.

    Directory of Open Access Journals (Sweden)

    Margaret E Hunter

    Full Text Available Environmental DNA (eDNA methods are used to detect DNA that is shed into the aquatic environment by cryptic or low density species. Applied in eDNA studies, occupancy models can be used to estimate occurrence and detection probabilities and thereby account for imperfect detection. However, occupancy terminology has been applied inconsistently in eDNA studies, and many have calculated occurrence probabilities while not considering the effects of imperfect detection. Low detection of invasive giant constrictors using visual surveys and traps has hampered the estimation of occupancy and detection estimates needed for population management in southern Florida, USA. Giant constrictor snakes pose a threat to native species and the ecological restoration of the Florida Everglades. To assist with detection, we developed species-specific eDNA assays using quantitative PCR (qPCR for the Burmese python (Python molurus bivittatus, Northern African python (P. sebae, boa constrictor (Boa constrictor, and the green (Eunectes murinus and yellow anaconda (E. notaeus. Burmese pythons, Northern African pythons, and boa constrictors are established and reproducing, while the green and yellow anaconda have the potential to become established. We validated the python and boa constrictor assays using laboratory trials and tested all species in 21 field locations distributed in eight southern Florida regions. Burmese python eDNA was detected in 37 of 63 field sampling events; however, the other species were not detected. Although eDNA was heterogeneously distributed in the environment, occupancy models were able to provide the first estimates of detection probabilities, which were greater than 91%. Burmese python eDNA was detected along the leading northern edge of the known population boundary. The development of informative detection tools and eDNA occupancy models can improve conservation efforts in southern Florida and support more extensive studies of invasive

  13. Environmental DNA (eDNA) sampling improves occurrence and detection estimates of invasive burmese pythons.

    Science.gov (United States)

    Hunter, Margaret E; Oyler-McCance, Sara J; Dorazio, Robert M; Fike, Jennifer A; Smith, Brian J; Hunter, Charles T; Reed, Robert N; Hart, Kristen M

    2015-01-01

    Environmental DNA (eDNA) methods are used to detect DNA that is shed into the aquatic environment by cryptic or low density species. Applied in eDNA studies, occupancy models can be used to estimate occurrence and detection probabilities and thereby account for imperfect detection. However, occupancy terminology has been applied inconsistently in eDNA studies, and many have calculated occurrence probabilities while not considering the effects of imperfect detection. Low detection of invasive giant constrictors using visual surveys and traps has hampered the estimation of occupancy and detection estimates needed for population management in southern Florida, USA. Giant constrictor snakes pose a threat to native species and the ecological restoration of the Florida Everglades. To assist with detection, we developed species-specific eDNA assays using quantitative PCR (qPCR) for the Burmese python (Python molurus bivittatus), Northern African python (P. sebae), boa constrictor (Boa constrictor), and the green (Eunectes murinus) and yellow anaconda (E. notaeus). Burmese pythons, Northern African pythons, and boa constrictors are established and reproducing, while the green and yellow anaconda have the potential to become established. We validated the python and boa constrictor assays using laboratory trials and tested all species in 21 field locations distributed in eight southern Florida regions. Burmese python eDNA was detected in 37 of 63 field sampling events; however, the other species were not detected. Although eDNA was heterogeneously distributed in the environment, occupancy models were able to provide the first estimates of detection probabilities, which were greater than 91%. Burmese python eDNA was detected along the leading northern edge of the known population boundary. The development of informative detection tools and eDNA occupancy models can improve conservation efforts in southern Florida and support more extensive studies of invasive constrictors

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

    Science.gov (United States)

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

    2010-06-01

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

  15. Quality improvement education to improve performance on ulcerative colitis quality measures and care processes aligned with National Quality Strategy priorities.

    Science.gov (United States)

    Greene, Laurence; Moreo, Kathleen

    2015-01-01

    Studies on inflammatory bowel disease (IBD) have reported suboptimal approaches to patient care. In the United States, the findings have motivated leading gastroenterology organizations to call for initiatives that support clinicians in aligning their practices with quality measures for IBD and priorities of the National Quality Strategy (NQS). We designed and implemented a quality improvement (QI) education program on ulcerative colitis in which patient charts were audited for 30 gastroenterologists before (n = 300 charts) and after (n = 290 charts) they participated in QI-focused educational activities. Charts were audited for nine measures, selected for their alignment with four NQS priorities: making care safer, ensuring patient engagement, promoting communication, and promoting effective treatment practices. Four of the measures, including guideline-directed vaccinations and assessments of disease type and activity, were part of the CMS Physician Quality Reporting System (PQRS). The other five measures involved counseling patients on various topics in ulcerative colitis management, documentation of side effects, assessment of adherence status, and simplification of dosing. The gastroenterologists also completed baseline and post-education surveys designed to assess qualitative outcomes. One of the educational interventions was a private audit feedback session conducted for each gastroenterologist. The sessions were designed to support participants in identifying measures reflecting suboptimal care quality and developing action plans for improvement. In continuous improvement cycles, follow-up interventions included QI tools and educational monographs. Across the nine chart variables, post-education improvements ranged from 0% to 48%, with a mean improvement of 15.9%. Survey findings revealed improvements in self-reported understanding of quality measures and intentions to apply them to practice, and lower rates of perceived significant barriers to high

  16. The CMS Muon System Alignment

    CERN Document Server

    Martinez Ruiz-Del-Arbol, P

    2009-01-01

    The alignment of the muon system of CMS is performed using different techniques: photogrammetry measurements, optical alignment and alignment with tracks. For track-based alignment, several methods are employed, ranging from a hit and impact point (HIP) algorithm and a procedure exploiting chamber overlaps to a global fit method based on the Millepede approach. For start-up alignment as long as available integrated luminosity is still significantly limiting the size of the muon sample from collisions, cosmic muon and beam halo signatures play a very strong role. During the last commissioning runs in 2008 the first aligned geometries have been produced and validated with data. The CMS offline computing infrastructure has been used in order to perform improved reconstructions. We present the computational aspects related to the calculation of alignment constants at the CERN Analysis Facility (CAF), the production and population of databases and the validation and performance in the official reconstruction. Also...

  17. A polarized view on DNA under tension

    Science.gov (United States)

    van Mameren, Joost; Vermeulen, Karen; Wuite, Gijs J. L.; Peterman, Erwin J. G.

    2018-03-01

    In the past decades, sensitive fluorescence microscopy techniques have contributed significantly to our understanding of the dynamics of DNA. The specific labeling of DNA using intercalating dyes has allowed for quantitative measurement of the thermal fluctuations the polymers undergo. On the other hand, recent advances in single-molecule manipulation techniques have unraveled the mechanical and elastic properties of this intricate polymer. Here, we have combined these two approaches to study the conformational dynamics of DNA under a wide range of tensions. Using polarized fluorescence microscopy in conjunction with optical-tweezers-based manipulation of YOYO-intercalated DNA, we controllably align the YOYO dyes using DNA tension, enabling us to disentangle the rapid dynamics of the dyes from that of the DNA itself. With unprecedented control of the DNA alignment, we resolve an inconsistency in reports about the tilted orientation of intercalated dyes. We find that intercalated dyes are on average oriented perpendicular to the long axis of the DNA, yet undergo fast dynamics on the time scale of absorption and fluorescence emission. In the overstretching transition of double-stranded DNA, we do not observe changes in orientation or orientational dynamics of the dyes. Only beyond the overstretching transition, a considerable depolarization is observed, presumably caused by an average tilting of the DNA base pairs. Our combined approach thus contributes to the elucidation of unique features of the molecular dynamics of DNA.

  18. An additional reference axis improves femoral rotation alignment in image-free computer navigation assisted total knee arthroplasty.

    Science.gov (United States)

    Inui, Hiroshi; Taketomi, Shuji; Nakamura, Kensuke; Sanada, Takaki; Tanaka, Sakae; Nakagawa, Takumi

    2013-05-01

    Few studies have demonstrated improvement in accuracy of rotational alignment using image-free navigation systems mainly due to the inconsistent registration of anatomical landmarks. We have used an image-free navigation for total knee arthroplasty, which adopts the average algorithm between two reference axes (transepicondylar axis and axis perpendicular to the Whiteside axis) for femoral component rotation control. We hypothesized that addition of another axis (condylar twisting axis measured on a preoperative radiograph) would improve the accuracy. One group using the average algorithm (double-axis group) was compared with the other group using another axis to confirm the accuracy of the average algorithm (triple-axis group). Femoral components were more accurately implanted for rotational alignment in the triple-axis group (ideal: triple-axis group 100%, double-axis group 82%, P<0.05). Copyright © 2013 Elsevier Inc. All rights reserved.

  19. Effects of variable attachment shapes and aligner material on aligner retention.

    Science.gov (United States)

    Dasy, Hiltrud; Dasy, Andreas; Asatrian, Greg; Rózsa, Noémi; Lee, Hao-Fu; Kwak, Jin Hee

    2015-11-01

    To evaluate the retention of four types of aligners on a dental arch with various attachments. For this study, three casts were manufactured, two of which contained attachments (ellipsoid and beveled), and one without any attachments to serve as a control. Four types of aligners were thermoformed: Clear-Aligner (CA)-soft, CA-medium, and CA-hard, with various thicknesses, and Essix ACE. Measurements of vertical displacement force during aligner removal were performed with the Gabo Qualimeter Eplexor. Means and standard deviations were next compared between different aligner thicknesses and attachment shapes. CA-soft, CA-medium, and CA-hard did not present a significant increase in retention, except when used in the presence of attachments. Additionally, CA-medium and CA-hard required significantly more force for removal. Essix ACE demonstrated a significant decrease in retention when used with ellipsoid attachments. The force value for Essix ACE removal from the cast with beveled attachments was comparable to that of CA-medium. Forces for aligner removal from the model without attachments showed a linear trend. Essix ACE did not show a continuous increase in retention for each model. Overall, ellipsoid attachments did not present a significant change in retention. In contrast, beveled attachments improved retention. Ellipsoid attachments had no significant influence on the force required for aligner removal and hence on aligner retention. Essix ACE showed significantly less retention than CA-hard on the models with attachments. Furthermore, beveled attachments were observed to increase retention significantly, compared with ellipsoid attachments and when using no attachments.

  20. Relation between film character and wafer alignment: critical alignment issues on HV device for VLSI manufacturing

    Science.gov (United States)

    Lo, Yi-Chuan; Lee, Chih-Hsiung; Lin, Hsun-Peng; Peng, Chiou-Shian

    1998-06-01

    Several continuous splits for wafer alignment target topography conditions to improve epitaxy film alignment were applied. The alignment evaluation among former layer pad oxide thickness (250 angstrom - 500 angstrom), drive oxide thickness (6000 angstrom - 10000 angstrom), nitride film thickness (600 angstrom - 1500 angstrom), initial oxide etch (fully wet etch, fully dry etch and dry plus wet etch) will be split to this experiment. Also various epitaxy deposition recipe such as: epitaxy source (SiHCl2 or SiCHCl3) and growth rate (1.3 micrometer/min approximately 2.0 micrometer/min) will be used to optimize the process window for alignment issue. All the reflectance signal and cross section photography of alignment target during NIKON stepper alignment process will be examined. Experimental results show epitaxy recipe plays an important role to wafer alignment. Low growth rate with good performance conformity epitaxy lead to alignment target avoid washout, pattern shift and distortion. All the results (signal monitor and film character) combined with NIKON's stepper standard laser scanning alignment system will be discussed in this paper.

  1. Tidal alignment of galaxies

    Energy Technology Data Exchange (ETDEWEB)

    Blazek, Jonathan; Vlah, Zvonimir; Seljak, Uroš

    2015-08-01

    We develop an analytic model for galaxy intrinsic alignments (IA) based on the theory of tidal alignment. We calculate all relevant nonlinear corrections at one-loop order, including effects from nonlinear density evolution, galaxy biasing, and source density weighting. Contributions from density weighting are found to be particularly important and lead to bias dependence of the IA amplitude, even on large scales. This effect may be responsible for much of the luminosity dependence in IA observations. The increase in IA amplitude for more highly biased galaxies reflects their locations in regions with large tidal fields. We also consider the impact of smoothing the tidal field on halo scales. We compare the performance of this consistent nonlinear model in describing the observed alignment of luminous red galaxies with the linear model as well as the frequently used "nonlinear alignment model," finding a significant improvement on small and intermediate scales. We also show that the cross-correlation between density and IA (the "GI" term) can be effectively separated into source alignment and source clustering, and we accurately model the observed alignment down to the one-halo regime using the tidal field from the fully nonlinear halo-matter cross correlation. Inside the one-halo regime, the average alignment of galaxies with density tracers no longer follows the tidal alignment prediction, likely reflecting nonlinear processes that must be considered when modeling IA on these scales. Finally, we discuss tidal alignment in the context of cosmic shear measurements.

  2. GenNon-h: Generating multiple sequence alignments on nonhomogeneous phylogenetic trees

    Directory of Open Access Journals (Sweden)

    Kedzierska Anna M

    2012-08-01

    Full Text Available Abstract Background A number of software packages are available to generate DNA multiple sequence alignments (MSAs evolved under continuous-time Markov processes on phylogenetic trees. On the other hand, methods of simulating the DNA MSA directly from the transition matrices do not exist. Moreover, existing software restricts to the time-reversible models and it is not optimized to generate nonhomogeneous data (i.e. placing distinct substitution rates at different lineages. Results We present the first package designed to generate MSAs evolving under discrete-time Markov processes on phylogenetic trees, directly from probability substitution matrices. Based on the input model and a phylogenetic tree in the Newick format (with branch lengths measured as the expected number of substitutions per site, the algorithm produces DNA alignments of desired length. GenNon-h is publicly available for download. Conclusion The software presented here is an efficient tool to generate DNA MSAs on a given phylogenetic tree. GenNon-h provides the user with the nonstationary or nonhomogeneous phylogenetic data that is well suited for testing complex biological hypotheses, exploring the limits of the reconstruction algorithms and their robustness to such models.

  3. Room temperature electrocompetent bacterial cells improve DNA transformation and recombineering efficiency.

    Science.gov (United States)

    Tu, Qiang; Yin, Jia; Fu, Jun; Herrmann, Jennifer; Li, Yuezhong; Yin, Yulong; Stewart, A Francis; Müller, Rolf; Zhang, Youming

    2016-04-20

    Bacterial competent cells are essential for cloning, construction of DNA libraries, and mutagenesis in every molecular biology laboratory. Among various transformation methods, electroporation is found to own the best transformation efficiency. Previous electroporation methods are based on washing and electroporating the bacterial cells in ice-cold condition that make them fragile and prone to death. Here we present simple temperature shift based methods that improve DNA transformation and recombineering efficiency in E. coli and several other gram-negative bacteria thereby economizing time and cost. Increased transformation efficiency of large DNA molecules is a significant advantage that might facilitate the cloning of large fragments from genomic DNA preparations and metagenomics samples.

  4. Improved DNA electrophoresis in conditions favoring polyborates and lewis acid complexation.

    Directory of Open Access Journals (Sweden)

    Hari Singhal

    2010-06-01

    Full Text Available Spatial compression among the longer DNA fragments occurs during DNA electrophoresis in agarose and non-agarose gels when using certain ions in the conductive buffer, impairing the range of fragment sizes resolved well in a single gel. Substitutions using various polyhydroxyl anions supported the underlying phenomenon as the complexation of Lewis acids to DNA. We saw significant improvements using conditions (lithium borate 10 mM cations, pH 6.5 favoring the formation of borate polyanions and having lower conductance and Joule heating, delayed electrolyte exhaustion, faster electrophoretic run-speed, and sharper separation of DNA bands from 100 bp to 12 kb in a single run.

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

  6. High-throughput sequence alignment using Graphics Processing Units

    Directory of Open Access Journals (Sweden)

    Trapnell Cole

    2007-12-01

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

  7. Biologically inspired EM image alignment and neural reconstruction.

    Science.gov (United States)

    Knowles-Barley, Seymour; Butcher, Nancy J; Meinertzhagen, Ian A; Armstrong, J Douglas

    2011-08-15

    Three-dimensional reconstruction of consecutive serial-section transmission electron microscopy (ssTEM) images of neural tissue currently requires many hours of manual tracing and annotation. Several computational techniques have already been applied to ssTEM images to facilitate 3D reconstruction and ease this burden. Here, we present an alternative computational approach for ssTEM image analysis. We have used biologically inspired receptive fields as a basis for a ridge detection algorithm to identify cell membranes, synaptic contacts and mitochondria. Detected line segments are used to improve alignment between consecutive images and we have joined small segments of membrane into cell surfaces using a dynamic programming algorithm similar to the Needleman-Wunsch and Smith-Waterman DNA sequence alignment procedures. A shortest path-based approach has been used to close edges and achieve image segmentation. Partial reconstructions were automatically generated and used as a basis for semi-automatic reconstruction of neural tissue. The accuracy of partial reconstructions was evaluated and 96% of membrane could be identified at the cost of 13% false positive detections. An open-source reference implementation is available in the Supplementary information. seymour.kb@ed.ac.uk; douglas.armstrong@ed.ac.uk Supplementary data are available at Bioinformatics online.

  8. LHCb's Time-Real Alignment in RunII

    CERN Multimedia

    Batozskaya, Varvara

    2015-01-01

    LHCb has introduced a novel real-time detector alignment and calibration strategy for LHC Run 2. Data collected at the start of the fill will be processed in a few minutes and used to update the alignment, while the calibration constants will be evaluated for each run. This procedure will improve the quality of the online alignment. Critically, this new real-time alignment and calibration procedure allows identical constants to be used in the online and offline reconstruction, thus improving the correlation between triggered and offline selected events. This offers the opportunity to optimise the event selection in the trigger by applying stronger constraints. The required computing time constraints are met thanks to a new dedicated framework using the multi-core farm infrastructure for the trigger. The motivation for a real-time alignment and calibration of the LHCb detector is discussed from both the operational and physics performance points of view. Specific challenges of this novel configur...

  9. Application of Improved 5th-Cubature Kalman Filter in Initial Strapdown Inertial Navigation System Alignment for Large Misalignment Angles.

    Science.gov (United States)

    Wang, Wei; Chen, Xiyuan

    2018-02-23

    In view of the fact the accuracy of the third-degree Cubature Kalman Filter (CKF) used for initial alignment under large misalignment angle conditions is insufficient, an improved fifth-degree CKF algorithm is proposed in this paper. In order to make full use of the innovation on filtering, the innovation covariance matrix is calculated recursively by an innovative sequence with an exponent fading factor. Then a new adaptive error covariance matrix scaling algorithm is proposed. The Singular Value Decomposition (SVD) method is used for improving the numerical stability of the fifth-degree CKF in this paper. In order to avoid the overshoot caused by excessive scaling of error covariance matrix during the convergence stage, the scaling scheme is terminated when the gradient of azimuth reaches the maximum. The experimental results show that the improved algorithm has better alignment accuracy with large misalignment angles than the traditional algorithm.

  10. RNA Structural Alignments, Part I

    DEFF Research Database (Denmark)

    Havgaard, Jakob Hull; Gorodkin, Jan

    2014-01-01

    Simultaneous alignment and secondary structure prediction of RNA sequences is often referred to as "RNA structural alignment." A class of the methods for structural alignment is based on the principles proposed by Sankoff more than 25 years ago. The Sankoff algorithm simultaneously folds and aligns...... is so high that it took more than a decade before the first implementation of a Sankoff style algorithm was published. However, with the faster computers available today and the improved heuristics used in the implementations the Sankoff-based methods have become practical. This chapter describes...... the methods based on the Sankoff algorithm. All the practical implementations of the algorithm use heuristics to make them run in reasonable time and memory. These heuristics are also described in this chapter....

  11. DNA barcoding the native flowering plants and conifers of Wales.

    Directory of Open Access Journals (Sweden)

    Natasha de Vere

    Full Text Available We present the first national DNA barcode resource that covers the native flowering plants and conifers for the nation of Wales (1143 species. Using the plant DNA barcode markers rbcL and matK, we have assembled 97.7% coverage for rbcL, 90.2% for matK, and a dual-locus barcode for 89.7% of the native Welsh flora. We have sampled multiple individuals for each species, resulting in 3304 rbcL and 2419 matK sequences. The majority of our samples (85% are from DNA extracted from herbarium specimens. Recoverability of DNA barcodes is lower using herbarium specimens, compared to freshly collected material, mostly due to lower amplification success, but this is balanced by the increased efficiency of sampling species that have already been collected, identified, and verified by taxonomic experts. The effectiveness of the DNA barcodes for identification (level of discrimination is assessed using four approaches: the presence of a barcode gap (using pairwise and multiple alignments, formation of monophyletic groups using Neighbour-Joining trees, and sequence similarity in BLASTn searches. These approaches yield similar results, providing relative discrimination levels of 69.4 to 74.9% of all species and 98.6 to 99.8% of genera using both markers. Species discrimination can be further improved using spatially explicit sampling. Mean species discrimination using barcode gap analysis (with a multiple alignment is 81.6% within 10×10 km squares and 93.3% for 2×2 km squares. Our database of DNA barcodes for Welsh native flowering plants and conifers represents the most complete coverage of any national flora, and offers a valuable platform for a wide range of applications that require accurate species identification.

  12. Simulation of high-resolution X-ray microscopic images for improved alignment

    International Nuclear Information System (INIS)

    Song Xiangxia; Zhang Xiaobo; Liu Gang; Cheng Xianchao; Li Wenjie; Guan Yong; Liu Ying; Xiong Ying; Tian Yangchao

    2011-01-01

    The introduction of precision optical elements to X-ray microscopes necessitates fine realignment to achieve optimal high-resolution imaging. In this paper, we demonstrate a numerical method for simulating image formation that facilitates alignment of the source, condenser, objective lens, and CCD camera. This algorithm, based on ray-tracing and Rayleigh-Sommerfeld diffraction theory, is applied to simulate the X-ray microscope beamline U7A of National Synchrotron Radiation Laboratory (NSRL). The simulations and imaging experiments show that the algorithm is useful for guiding experimental adjustments. Our alignment simulation method is an essential tool for the transmission X-ray microscope (TXM) with optical elements and may also be useful for the alignment of optical components in other modes of microscopy.

  13. Improving accountability through alignment: the role of academic health science centres and networks in England.

    Science.gov (United States)

    Ovseiko, Pavel V; Heitmueller, Axel; Allen, Pauline; Davies, Stephen M; Wells, Glenn; Ford, Gary A; Darzi, Ara; Buchan, Alastair M

    2014-01-20

    As in many countries around the world, there are high expectations on academic health science centres and networks in England to provide high-quality care, innovative research, and world-class education, while also supporting wealth creation and economic growth. Meeting these expectations increasingly depends on partnership working between university medical schools and teaching hospitals, as well as other healthcare providers. However, academic-clinical relationships in England are still characterised by the "unlinked partners" model, whereby universities and their partner teaching hospitals are neither fiscally nor structurally linked, creating bifurcating accountabilities to various government and public agencies. This article focuses on accountability relationships in universities and teaching hospitals, as well as other healthcare providers that form core constituent parts of academic health science centres and networks. The authors analyse accountability for the tripartite mission of patient care, research, and education, using a four-fold typology of accountability relationships, which distinguishes between hierarchical (bureaucratic) accountability, legal accountability, professional accountability, and political accountability. Examples from North West London suggest that a number of mechanisms can be used to improve accountability for the tripartite mission through alignment, but that the simple creation of academic health science centres and networks is probably not sufficient. At the heart of the challenge for academic health science centres and networks is the separation of accountabilities for patient care, research, and education in different government departments. Given that a fundamental top-down system redesign is now extremely unlikely, local academic and clinical leaders face the challenge of aligning their institutions as a matter of priority in order to improve accountability for the tripartite mission from the bottom up. It remains to be

  14. Benchmarking spliced alignment programs including Spaln2, an extended version of Spaln that incorporates additional species-specific features.

    Science.gov (United States)

    Iwata, Hiroaki; Gotoh, Osamu

    2012-11-01

    Spliced alignment plays a central role in the precise identification of eukaryotic gene structures. Even though many spliced alignment programs have been developed, recent rapid progress in DNA sequencing technologies demands further improvements in software tools. Benchmarking algorithms under various conditions is an indispensable task for the development of better software; however, there is a dire lack of appropriate datasets usable for benchmarking spliced alignment programs. In this study, we have constructed two types of datasets: simulated sequence datasets and actual cross-species datasets. The datasets are designed to correspond to various real situations, i.e. divergent eukaryotic species, different types of reference sequences, and the wide divergence between query and target sequences. In addition, we have developed an extended version of our program Spaln, which incorporates two additional features to the scoring scheme of the original version, and examined this extended version, Spaln2, together with the original Spaln and other representative aligners based on our benchmark datasets. Although the effects of the modifications are not individually striking, Spaln2 is consistently most accurate and reasonably fast in most practical cases, especially for plants and fungi and for increasingly divergent pairs of target and query sequences.

  15. INDUCED EEG GAMMA OSCILLATION ALIGNMENT IMPROVES DIFFERENTIATION BETWEEN AUTISM AND ADHD GROUP RESPONSES IN A FACIAL CATEGORIZATION TASK.

    Science.gov (United States)

    Gross, Eric; El-Baz, Ayman S; Sokhadze, Guela E; Sears, Lonnie; Casanova, Manuel F; Sokhadze, Estate M

    2012-01-01

    INTRODUCTION: Children diagnosed with an autism spectrum disorder (ASD) often lack the ability to recognize and properly respond to emotional stimuli. Emotional deficits also characterize children with attention deficit/hyperactivity disorder (ADHD), in addition to exhibiting limited attention span. These abnormalities may effect a difference in the induced EEG gamma wave burst (35-45 Hz) peaked approximately 300-400 milliseconds following an emotional stimulus. Because induced gamma oscillations are not fixed at a definite point in time post-stimulus, analysis of averaged EEG data with traditional methods may result in an attenuated gamma burst power. METHODS: We used a data alignment technique to improve the averaged data, making it a better representation of the individual induced EEG gamma oscillations. A study was designed to test the response of a subject to emotional stimuli, presented in the form of emotional facial expression images. In a four part experiment, the subjects were instructed to identify gender in the first two blocks of the test, followed by differentiating between basic emotions in the final two blocks (i.e. anger vs. disgust). EEG data was collected from ASD (n=10), ADHD (n=9), and control (n=11) subjects via a 128 channel EGI system, and processed through a continuous wavelet transform and bandpass filter to isolate the gamma frequencies. A custom MATLAB code was used to align the data from individual trials between 200-600 ms post-stimulus, EEG site, and condition by maximizing the Pearson product-moment correlation coefficient between trials. The gamma power for the 400 ms window of maximum induced gamma burst was then calculated and compared between subject groups. RESULTS AND CONCLUSION: Condition (anger/disgust recognition, gender recognition) × Alignment × Group (ADHD, ASD, Controls) interaction was significant at most of parietal topographies (e.g., P3-P4, P7-P8). These interactions were better manifested in the aligned data set

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

    Science.gov (United States)

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

    2014-08-01

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

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

  18. Improving the accuracy of protein secondary structure prediction using structural alignment

    Directory of Open Access Journals (Sweden)

    Gallin Warren J

    2006-06-01

    Full Text Available Abstract Background The accuracy of protein secondary structure prediction has steadily improved over the past 30 years. Now many secondary structure prediction methods routinely achieve an accuracy (Q3 of about 75%. We believe this accuracy could be further improved by including structure (as opposed to sequence database comparisons as part of the prediction process. Indeed, given the large size of the Protein Data Bank (>35,000 sequences, the probability of a newly identified sequence having a structural homologue is actually quite high. Results We have developed a method that performs structure-based sequence alignments as part of the secondary structure prediction process. By mapping the structure of a known homologue (sequence ID >25% onto the query protein's sequence, it is possible to predict at least a portion of that query protein's secondary structure. By integrating this structural alignment approach with conventional (sequence-based secondary structure methods and then combining it with a "jury-of-experts" system to generate a consensus result, it is possible to attain very high prediction accuracy. Using a sequence-unique test set of 1644 proteins from EVA, this new method achieves an average Q3 score of 81.3%. Extensive testing indicates this is approximately 4–5% better than any other method currently available. Assessments using non sequence-unique test sets (typical of those used in proteome annotation or structural genomics indicate that this new method can achieve a Q3 score approaching 88%. Conclusion By using both sequence and structure databases and by exploiting the latest techniques in machine learning it is possible to routinely predict protein secondary structure with an accuracy well above 80%. A program and web server, called PROTEUS, that performs these secondary structure predictions is accessible at http://wishart.biology.ualberta.ca/proteus. For high throughput or batch sequence analyses, the PROTEUS programs

  19. Improving head and body pose estimation through semi-supervised manifold alignment

    KAUST Repository

    Heili, Alexandre

    2014-10-27

    In this paper, we explore the use of a semi-supervised manifold alignment method for domain adaptation in the context of human body and head pose estimation in videos. We build upon an existing state-of-the-art system that leverages on external labelled datasets for the body and head features, and on the unlabelled test data with weak velocity labels to do a coupled estimation of the body and head pose. While this previous approach showed promising results, the learning of the underlying manifold structure of the features in the train and target data and the need to align them were not explored despite the fact that the pose features between two datasets may vary according to the scene, e.g. due to different camera point of view or perspective. In this paper, we propose to use a semi-supervised manifold alignment method to bring the train and target samples closer within the resulting embedded space. To this end, we consider an adaptation set from the target data and rely on (weak) labels, given for example by the velocity direction whenever they are reliable. These labels, along with the training labels are used to bias the manifold distance within each manifold and to establish correspondences for alignment.

  20. Synthesis of CdS nanoparticles based on DNA network templates

    International Nuclear Information System (INIS)

    Yao Yong; Song Yonghai; Wang Li

    2008-01-01

    CdS nanoparticles have been successfully synthesized by using DNA networks as templates. The synthesis was carried out by first dropping a mixture of cadmium acetate and DNA on a mica surface for the formation of the DNA network template and then transferring the sample into a heated thiourea solution. The Cd 2+ reacted with thiourea at high temperature and formed CdS nanoparticles on the DNA network template. UV-vis spectroscopy, photoluminescence, x-ray diffraction and atomic force microscopy (AFM) were used to characterize the CdS nanoparticles in detail. AFM results showed that the resulted CdS nanoparticles were directly aligned on the DNA network templates and that the synthesis and assembly of CdS nanoparticles was realized in one step. CdS nanoparticles fabricated with this method were smaller than those directly synthesized in a thiourea solution and were uniformly aligned on the DNA networks. By adjusting the density of the DNA networks and the concentration of Cd 2+ , the size and density of the CdS nanoparticles could be effectively controlled and CdS nanoparticles could grow along the DNA chains into nanowires. The possible growth mechanism has also been discussed in detail

  1. CORAL: aligning conserved core regions across domain families.

    Science.gov (United States)

    Fong, Jessica H; Marchler-Bauer, Aron

    2009-08-01

    Homologous protein families share highly conserved sequence and structure regions that are frequent targets for comparative analysis of related proteins and families. Many protein families, such as the curated domain families in the Conserved Domain Database (CDD), exhibit similar structural cores. To improve accuracy in aligning such protein families, we propose a profile-profile method CORAL that aligns individual core regions as gap-free units. CORAL computes optimal local alignment of two profiles with heuristics to preserve continuity within core regions. We benchmarked its performance on curated domains in CDD, which have pre-defined core regions, against COMPASS, HHalign and PSI-BLAST, using structure superpositions and comprehensive curator-optimized alignments as standards of truth. CORAL improves alignment accuracy on core regions over general profile methods, returning a balanced score of 0.57 for over 80% of all domain families in CDD, compared with the highest balanced score of 0.45 from other methods. Further, CORAL provides E-values to aid in detecting homologous protein families and, by respecting block boundaries, produces alignments with improved 'readability' that facilitate manual refinement. CORAL will be included in future versions of the NCBI Cn3D/CDTree software, which can be downloaded at http://www.ncbi.nlm.nih.gov/Structure/cdtree/cdtree.shtml. Supplementary data are available at Bioinformatics online.

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

  3. DNA structure in human RNA polymerase II promoters

    DEFF Research Database (Denmark)

    Pedersen, Anders Gorm; Baldi, Pierre; Chauvin, Yves

    1998-01-01

    with a very low level of sequence similarity. The sequences, which include both TATA-containing and TATA-less promoters, are aligned by hidden Markov models. Using three different models of sequence-derived DNA bendability, the aligned promoters display a common structural profile with bendability being low...... protein in a manner reminiscent of DNA in a nucleosome. This notion is further supported by the finding that the periodic bendability is caused mainly by the complementary triplet pairs CAG/CTG and GGC/GCC, which previously have been found to correlate with nucleosome positioning. We present models where......The fact that DNA three-dimensional structure is important for transcriptional regulation begs the question of whether eukaryotic promoters contain general structural features independently of what genes they control. We present an analysis of a large set of human RNA polymerase II promoters...

  4. Ribosomal DNA internal transcribed spacer 1 and internal ...

    African Journals Online (AJOL)

    USER

    2010-07-26

    Jul 26, 2010 ... in some East Asian countries such as China, Korea and. *Corresponding author. E-mail: soonkwan@kangwon.ac.kr. Tel: +82 33 250 6476. Fax: +82 33 250 6470. Abbreviations: nrDNA, Nuclear ribosomal DNA; ITS, internal transcribed spacer; PCR, polymerase chain reaction; BLAST, basic local alignment ...

  5. Exogenous DNA internalisation by sperm cells is improved by combining lipofection and restriction enzyme mediated integration.

    Science.gov (United States)

    Churchil, R R; Gupta, J; Singh, A; Sharma, D

    2011-06-01

    1. Three types of exogenous DNA inserts, i.e. complete linearised pVIVO2-GFP/LacZ vector (9620 bp), the LacZ gene (5317 bp) and the GFP gene (2152 bp) were used to transfect chicken spermatozoa through simple incubation of sperm cells with insert. 2. PCR assay, Dot Blot hybridisation and Southern hybridisation showed the successful internalisation of exogenous DNA by chicken sperm cells. 3. Lipofection and Restriction Enzyme Mediated Integration (REMI) were used to improve the rate of internalisation of exogenous DNA by sperm cells. 4. Results from dot blot as well as Southern hybridisation were semi-quantified and improved exogenous DNA uptake by sperm cells through lipofection and REMI. Stronger signals were observed from hybridisation of LacZ as well as GFP specific probe with the DNA from lipofected exogenous DNA transfected sperm DNA in comparison with those transfected with nude exogenous DNA.

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

    Directory of Open Access Journals (Sweden)

    Guillaume Marçais

    2018-01-01

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

  7. Multiple Whole Genome Alignments and Novel Biomedical Applicationsat the VISTA Portal

    Energy Technology Data Exchange (ETDEWEB)

    Brudno, Michael; Poliakov, Alexander; Minovitsky, Simon; Ratnere,Igor; Dubchak, Inna

    2007-02-01

    The VISTA portal for comparative genomics is designed togive biomedical scientists a unified set of tools to lead them from theraw DNA sequences through the alignment and annotation to thevisualization of the results. The VISTA portal also hosts alignments of anumber of genomes computed by our group, allowing users to study regionsof their interest without having to manually download the individualsequences. Here we describe various algorithmic and functionalimprovements implemented in the VISTA portal over the last two years. TheVISTA Portal is accessible at http://genome.lbl.gov/vista.

  8. Programmed Switching of Single Polymer Conformation on DNA Origami

    DEFF Research Database (Denmark)

    Krissanaprasit, Abhichart; Madsen, Mikael; Knudsen, Jakob Bach

    2016-01-01

    -molecule conjugated polymer. The polymer is functionalized with short single-stranded (ss) DNA strands that extend from the backbone of the polymer and serve as handles. The DNA polymer conjugate can be aligned on DNA origami in three well-defined geometries (straight line, left-turned, and right-turned pattern......) by DNA hybridization directed by single-stranded guiding strands and ssDNA tracks extending from the origami surface and polymer handle. We demonstrate switching of a conjugated organic polymer conformation between left- and right-turned conformations of the polymer on DNA origami based on toehold...

  9. OXBench: A benchmark for evaluation of protein multiple sequence alignment accuracy

    Directory of Open Access Journals (Sweden)

    Searle Stephen MJ

    2003-10-01

    Full Text Available Abstract Background The alignment of two or more protein sequences provides a powerful guide in the prediction of the protein structure and in identifying key functional residues, however, the utility of any prediction is completely dependent on the accuracy of the alignment. In this paper we describe a suite of reference alignments derived from the comparison of protein three-dimensional structures together with evaluation measures and software that allow automatically generated alignments to be benchmarked. We test the OXBench benchmark suite on alignments generated by the AMPS multiple alignment method, then apply the suite to compare eight different multiple alignment algorithms. The benchmark shows the current state-of-the art for alignment accuracy and provides a baseline against which new alignment algorithms may be judged. Results The simple hierarchical multiple alignment algorithm, AMPS, performed as well as or better than more modern methods such as CLUSTALW once the PAM250 pair-score matrix was replaced by a BLOSUM series matrix. AMPS gave an accuracy in Structurally Conserved Regions (SCRs of 89.9% over a set of 672 alignments. The T-COFFEE method on a data set of families with http://www.compbio.dundee.ac.uk. Conclusions The OXBench suite of reference alignments, evaluation software and results database provide a convenient method to assess progress in sequence alignment techniques. Evaluation measures that were dependent on comparison to a reference alignment were found to give good discrimination between methods. The STAMP Sc Score which is independent of a reference alignment also gave good discrimination. Application of OXBench in this paper shows that with the exception of T-COFFEE, the majority of the improvement in alignment accuracy seen since 1985 stems from improved pair-score matrices rather than algorithmic refinements. The maximum theoretical alignment accuracy obtained by pooling results over all methods was 94

  10. Enhanced Dynamic Algorithm of Genome Sequence Alignments

    OpenAIRE

    Arabi E. keshk

    2014-01-01

    The merging of biology and computer science has created a new field called computational biology that explore the capacities of computers to gain knowledge from biological data, bioinformatics. Computational biology is rooted in life sciences as well as computers, information sciences, and technologies. The main problem in computational biology is sequence alignment that is a way of arranging the sequences of DNA, RNA or protein to identify the region of similarity and relationship between se...

  11. Ontology Alignment Repair through Modularization and Confidence-Based Heuristics.

    Directory of Open Access Journals (Sweden)

    Emanuel Santos

    Full Text Available Ontology Matching aims at identifying a set of semantic correspondences, called an alignment, between related ontologies. In recent years, there has been a growing interest in efficient and effective matching methods for large ontologies. However, alignments produced for large ontologies are often logically incoherent. It was only recently that the use of repair techniques to improve the coherence of ontology alignments began to be explored. This paper presents a novel modularization technique for ontology alignment repair which extracts fragments of the input ontologies that only contain the necessary classes and relations to resolve all detectable incoherences. The paper presents also an alignment repair algorithm that uses a global repair strategy to minimize both the degree of incoherence and the number of mappings removed from the alignment, while overcoming the scalability problem by employing the proposed modularization technique. Our evaluation shows that our modularization technique produces significantly small fragments of the ontologies and that our repair algorithm produces more complete alignments than other current alignment repair systems, while obtaining an equivalent degree of incoherence. Additionally, we also present a variant of our repair algorithm that makes use of the confidence values of the mappings to improve alignment repair. Our repair algorithm was implemented as part of AgreementMakerLight, a free and open-source ontology matching system.

  12. Ontology Alignment Repair through Modularization and Confidence-Based Heuristics.

    Science.gov (United States)

    Santos, Emanuel; Faria, Daniel; Pesquita, Catia; Couto, Francisco M

    2015-01-01

    Ontology Matching aims at identifying a set of semantic correspondences, called an alignment, between related ontologies. In recent years, there has been a growing interest in efficient and effective matching methods for large ontologies. However, alignments produced for large ontologies are often logically incoherent. It was only recently that the use of repair techniques to improve the coherence of ontology alignments began to be explored. This paper presents a novel modularization technique for ontology alignment repair which extracts fragments of the input ontologies that only contain the necessary classes and relations to resolve all detectable incoherences. The paper presents also an alignment repair algorithm that uses a global repair strategy to minimize both the degree of incoherence and the number of mappings removed from the alignment, while overcoming the scalability problem by employing the proposed modularization technique. Our evaluation shows that our modularization technique produces significantly small fragments of the ontologies and that our repair algorithm produces more complete alignments than other current alignment repair systems, while obtaining an equivalent degree of incoherence. Additionally, we also present a variant of our repair algorithm that makes use of the confidence values of the mappings to improve alignment repair. Our repair algorithm was implemented as part of AgreementMakerLight, a free and open-source ontology matching system.

  13. A MapReduce Framework for DNA Sequencing Data Processing

    Directory of Open Access Journals (Sweden)

    Samy Ghoneimy

    2016-12-01

    Full Text Available Genomics and Next Generation Sequencers (NGS like Illumina Hiseq produce data in the order of ‎‎200 billion base pairs in a single one-week run for a 60x human genome coverage, which ‎requires modern high-throughput experimental technologies that can ‎only be tackled with high performance computing (HPC and specialized software algorithms called ‎‎“short read aligners”. This paper focuses on the implementation of the DNA sequencing as a set of MapReduce programs that will accept a DNA data set as a FASTQ file and finally generate a VCF (variant call format file, which has variants for a given DNA data set. In this paper MapReduce/Hadoop along with Burrows-Wheeler Aligner (BWA, Sequence Alignment/Map (SAM ‎tools, are fully utilized to provide various utilities for manipulating alignments, including sorting, merging, indexing, ‎and generating alignments. The Map-Sort-Reduce process is designed to be suited for a Hadoop framework in ‎which each cluster is a traditional N-node Hadoop cluster to utilize all of the Hadoop features like HDFS, program ‎management and fault tolerance. The Map step performs multiple instances of the short read alignment algorithm ‎‎(BoWTie that run in parallel in Hadoop. The ordered list of the sequence reads are used as input tuples and the ‎output tuples are the alignments of the short reads. In the Reduce step many parallel instances of the Short ‎Oligonucleotide Analysis Package for SNP (SOAPsnp algorithm run in the cluster. Input tuples are sorted ‎alignments for a partition and the output tuples are SNP calls. Results are stored via HDFS, and then archived in ‎SOAPsnp format. ‎ The proposed framework enables extremely fast discovering somatic mutations, inferring population genetical ‎parameters, and performing association tests directly based on sequencing data without explicit genotyping or ‎linkage-based imputation. It also demonstrate that this method achieves comparable

  14. Improved accuracy of component alignment with the implementation of image-free navigation in total knee arthroplasty.

    Science.gov (United States)

    Rosenberger, Ralf E; Hoser, Christian; Quirbach, Sebastian; Attal, Rene; Hennerbichler, Alfred; Fink, Christian

    2008-03-01

    Accuracy of implant positioning and reconstruction of the mechanical leg axis are major requirements for achieving good long-term results in total knee arthroplasty (TKA). The purpose of the present study was to determine whether image-free computer navigation technology has the potential to improve the accuracy of component alignment in TKA cohorts of experienced surgeons immediately and constantly. One hundred patients with primary arthritis of the knee underwent the unilateral total knee arthroplasty. The cohort of 50 TKAs implanted with conventional instrumentation was directly followed by the cohort of the very first 50 computer-assisted TKAs. All surgeries were performed by two senior surgeons. All patients received the Zimmer NexGen total knee prosthesis (Zimmer Inc., Warsaw, IN, USA). There was no variability regarding surgeons or surgical technique, except for the use of the navigation system (StealthStation) Treon plus Medtronic Inc., Minnesota, MI, USA). Accuracy of implant positioning was measured on postoperative long-leg standing radiographs and standard lateral X-rays with regard to the valgus angle and the coronal and sagittal component angles. In addition, preoperative deformities of the mechanical leg axis, tourniquet time, age, and gender were correlated. Statistical analyses were performed using the SPSS 15.0 (SPSS Inc., Chicago, IL, USA) software package. Independent t-tests were used, with significance set at P alignment between the two cohorts. To compute the rate of optimally implanted prostheses between the two groups we used the chi(2) test. The average postoperative radiological frontal mechanical alignment was 1.88 degrees of varus (range 6.1 degrees of valgus-10.1 degrees of varus; SD 3.68 degrees ) in the conventional cohort and 0.28 degrees of varus (range 3.7 degrees -6.0 degrees of varus; SD 1.97 degrees ) in the navigated cohort. Including all criteria for optimal implant alignment, 16 cases (32%) in the conventional cohort and 31

  15. DNA-dependent protein kinase in nonhomologous end joining: a lock with multiple keys?

    Science.gov (United States)

    Weterings, Eric; Chen, David J

    2007-10-22

    The DNA-dependent protein kinase (DNA-PK) is one of the central enzymes involved in DNA double-strand break (DSB) repair. It facilitates proper alignment of the two ends of the broken DNA molecule and coordinates access of other factors to the repair complex. We discuss the latest findings on DNA-PK phosphorylation and offer a working model for the regulation of DNA-PK during DSB repair.

  16. Assessing fit, interplay, and scale: Aligning governance and information for improved water management in a changing climate

    Science.gov (United States)

    Kirchhoff, C.; Dilling, L.

    2011-12-01

    Water managers have long experienced the challenges of managing water resources in a variable climate. However, climate change has the potential to reshape the experiential landscape by, for example, increasing the intensity and duration of droughts, shifting precipitation timing and amounts, and changing sea levels. Given the uncertainty in evaluating potential climate risks as well as future water availability and water demands, scholars suggest water managers employ more flexible and adaptive science-based management to manage uncertainty (NRC 2009). While such an approach is appropriate, for adaptive science-based management to be effective both governance and information must be concordant across three measures: fit, interplay and scale (Young 2002)(Note 1). Our research relies on interviews of state water managers and related experts (n=50) and documentary analysis in five U.S. states to understand the drivers and constraints to improving water resource planning and decision-making in a changing climate using an assessment of fit, interplay and scale as an evaluative framework. We apply this framework to assess and compare how water managers plan and respond to current or anticipated water resource challenges within each state. We hypothesize that better alignment between the data and management framework and the water resource problem improves water managers' facility to understand (via available, relevant, timely information) and respond appropriately (through institutional response mechanisms). In addition, better alignment between governance mechanisms (between the scope of the problem and identified appropriate responses) improves water management. Moreover, because many of the management challenges analyzed in this study concern present day issues with scarcity brought on by a combination of growth and drought, better alignment of fit, interplay, and scale today will enable and prepare water managers to be more successful in adapting to climate change

  17. Alignment performance monitoring for ASML systems

    Science.gov (United States)

    Chung, Woong-Jae; Temchenko, Vlad; Hauck, Tarja; Schmidt, Sebastian

    2006-03-01

    In today's semiconductor industry downscaling of the IC design puts a stringent requirement on pattern overlay control. Tighter overlay requirements lead to exceedingly higher rework rates, meaning additional costs to manufacturing. Better alignment control became a target of engineering efforts to decrease rework rate for high-end technologies. Overlay performance is influenced by known parameters such as "Shift, Scaling, Rotation, etc", and unknown parameters defined as "Process Induced Variation", which are difficult to control by means of a process automation system. In reality, this process-induced variation leads to a strong wafer to wafer, or lot to lot variation, which are not easy to detect in the mass-production environment which uses sampling overlay measurements for only several wafers in a lot. An engineering task of finding and correcting a root cause for Process Induced Variations of overlay performance will be greatly simplified if the unknown parameters could be tracked for each wafer. This paper introduces an alignment performance monitoring method based on analysis of automatically generated "AWE" files for ASML scanner systems. Because "AWE" files include alignment results for each aligned wafer, it is possible to use them for monitoring, controlling and correcting the causes of "process induced" overlay performance without requiring extra measurement time. Since "AWE" files include alignment information for different alignment marks, it is also possible to select and optimize the best alignment recipe for each alignment strategy. Several case studies provided in our paper will demonstrate how AWE file analysis can be used to assist engineer in interpreting pattern alignment data. Since implementing our alignment data monitoring method, we were able to achieve significant improvement of alignment and overlay performance without additional overlay measurement time. We also noticed that the rework rate coming from alignment went down and

  18. Modified alignment CGHs for aspheric surface test

    Science.gov (United States)

    Song, Jae-Bong; Yang, Ho-Soon; Rhee, Hyug-Gyo; Lee, Yun-Woo

    2009-08-01

    Computer Generated Holograms (CGH) for optical test are commonly consisted of one main pattern for testing aspheric surface and some alignment patterns for aligning the interferometer, CGH, and the test optics. To align the CGH plate and the test optics, we designed the alignment CGHs modified from the cat's eye alignment method, which are consisted of a couple of CGH patterns. The incident beam passed through the one part of the alignment CGH pattern is focused onto the one radius position of the test aspheric surface, and is reflected to the other part, and vice versa. This method has several merits compared to the conventional cat's eye alignment method. First, this method can be used in testing optics with a center hole, and the center part of CGH plate can be assigned to the alignment pattern. Second, the alignment pattern becomes a concentric circular arc pattern. The whole CGH patterns including the main pattern and alignment patterns are consisted of only concentric circular fringes. This concentric circular pattern can be easily made by the polar coordinated writer with circular scanning. The required diffraction angle becomes relatively small, so the 1st order diffraction beams instead of the 3rd order diffraction beam can be used as alignment beams, and the visibility can be improved. This alignment method also is more sensitive to the tilt and the lateral shift of the test aspheric surface. Using this alignment pattern, a 200 mm diameter F/0.5 aspheric mirror and a 600 mm diameter F/0.9 mirror were tested.

  19. Occlusion therapy improves phase-alignment of the cortical response in amblyopia.

    Science.gov (United States)

    Kelly, John P; Tarczy-Hornoch, Kristina; Herlihy, Erin; Weiss, Avery H

    2015-09-01

    The visual evoked potential (VEP) generated by the amblyopic visual system demonstrates reduced amplitude, prolonged latency, and increased variation in response timing (phase-misalignment). This study examined VEPs before and after occlusion therapy (OT) and whether phase-misalignment can account for the amblyopic VEP deficits. VEPs were recorded to 0.5-4cycles/degree gratings in 10 amblyopic children (2-6years age) before and after OT. Phase-misalignment was measured by Fourier analysis across a limited bandwidth. Signal-to-noise ratios (SNRs) were estimated from amplitude and phase synchrony in the Fourier domain. Responses were compared to VEPs corrected for phase-misalignment (individual epochs shifted in time to correct for the misalignment). Before OT, amblyopic eyes (AE) had significantly more phase-misalignment, latency prolongation, and lower SNR relative to the fellow eye. Phase-misalignment contributed significantly to low SNR but less so to latency delay in the AE. After OT, phase-alignment improved, SNR improved and latency shortened in the AE. Raw averaged waveforms from the AE improved after OT, primarily at higher spatial frequencies. Correcting for phase-misalignment in the AE sharpened VEP peak responses primarily at low spatial frequencies, but could not account for VEP waveform improvements in the AE after OT at higher spatial frequencies. In summary, VEP abnormalities from the AE are associated with phase-misalignment and reduced SNR possibly related to desynchronization of neuronal activity. The effect of OT on VEP responses is greater than that accounted for by phase-misalignment and SNR alone. Copyright © 2014 Elsevier Ltd. All rights reserved.

  20. Coupling SIMD and SIMT architectures to boost performance of a phylogeny-aware alignment kernel

    Directory of Open Access Journals (Sweden)

    Alachiotis Nikolaos

    2012-08-01

    Full Text Available Abstract Background Aligning short DNA reads to a reference sequence alignment is a prerequisite for detecting their biological origin and analyzing them in a phylogenetic context. With the PaPaRa tool we introduced a dedicated dynamic programming algorithm for simultaneously aligning short reads to reference alignments and corresponding evolutionary reference trees. The algorithm aligns short reads to phylogenetic profiles that correspond to the branches of such a reference tree. The algorithm needs to perform an immense number of pairwise alignments. Therefore, we explore vector intrinsics and GPUs to accelerate the PaPaRa alignment kernel. Results We optimized and parallelized PaPaRa on CPUs and GPUs. Via SSE 4.1 SIMD (Single Instruction, Multiple Data intrinsics for x86 SIMD architectures and multi-threading, we obtained a 9-fold acceleration on a single core as well as linear speedups with respect to the number of cores. The peak CPU performance amounts to 18.1 GCUPS (Giga Cell Updates per Second using all four physical cores on an Intel i7 2600 CPU running at 3.4 GHz. The average CPU performance (averaged over all test runs is 12.33 GCUPS. We also used OpenCL to execute PaPaRa on a GPU SIMT (Single Instruction, Multiple Threads architecture. A NVIDIA GeForce 560 GPU delivered peak and average performance of 22.1 and 18.4 GCUPS respectively. Finally, we combined the SIMD and SIMT implementations into a hybrid CPU-GPU system that achieved an accumulated peak performance of 33.8 GCUPS. Conclusions This accelerated version of PaPaRa (available at http://www.exelixis-lab.org/software.html provides a significant performance improvement that allows for analyzing larger datasets in less time. We observe that state-of-the-art SIMD and SIMT architectures deliver comparable performance for this dynamic programming kernel when the “competing programmer approach” is deployed. Finally, we show that overall performance can be substantially increased

  1. AlignMe—a membrane protein sequence alignment web server

    Science.gov (United States)

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

    2014-01-01

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

  2. PriFi - Using a Multiple Alignment of Related Sequences to Find Primers for  Amplification of Homologs

    DEFF Research Database (Denmark)

    Fredslund, Jakob; Schauser, Leif; Madsen, Lene Heegaard

    2005-01-01

    Using a comparative approach, the web program PriFi (http://cgi-www.daimi.au.dk/cgi-chili/PriFi/main) designs pairs of primers useful for PCR amplification of genomic DNA in species where prior sequence information is not available. The program works with an alignment of DNA sequences from phylog...

  3. Improvement in the amine glass platform by bubbling method for a DNA microarray.

    Science.gov (United States)

    Jee, Seung Hyun; Kim, Jong Won; Lee, Ji Hyeong; Yoon, Young Soo

    2015-01-01

    A glass platform with high sensitivity for sexually transmitted diseases microarray is described here. An amino-silane-based self-assembled monolayer was coated on the surface of a glass platform using a novel bubbling method. The optimized surface of the glass platform had highly uniform surface modifications using this method, as well as improved hybridization properties with capture probes in the DNA microarray. On the basis of these results, the improved glass platform serves as a highly reliable and optimal material for the DNA microarray. Moreover, in this study, we demonstrated that our glass platform, manufactured by utilizing the bubbling method, had higher uniformity, shorter processing time, lower background signal, and higher spot signal than the platforms manufactured by the general dipping method. The DNA microarray manufactured with a glass platform prepared using bubbling method can be used as a clinical diagnostic tool.

  4. An aligned porous electrospun fibrous membrane with controlled drug delivery - An efficient strategy to accelerate diabetic wound healing with improved angiogenesis.

    Science.gov (United States)

    Ren, Xiaozhi; Han, Yiming; Wang, Jie; Jiang, Yuqi; Yi, Zhengfang; Xu, He; Ke, Qinfei

    2018-04-01

    A chronic wound in diabetic patients is usually characterized by poor angiogenesis and delayed wound closure. The exploration of efficient strategy to significantly improve angiogenesis in the diabetic wound bed and thereby accelerate wound healing is still a significant challenge. Herein, we reported a kind of aligned porous poly (l-lactic acid) (PlLA) electrospun fibrous membranes containing dimethyloxalylglycine (DMOG)-loaded mesoporous silica nanoparticles (DS) for diabetic wound healing. The PlLA electrospun fibers aligned in a single direction and there were ellipse-shaped nano-pores in situ generated onto the surface of fibers, while the DS were well distributed in the fibers and the DMOG as well as Si ion could be controlled released from the nanopores on the fibers. The in vitro results revealed that the aligned porous composite membranes (DS-PL) could stimulate the proliferation, migration and angiogenesis-related gene expression of human umbilical vein endothelial cells (HUVECs) compared with the pure PlLA membranes. The in vivo study further demonstrated that the prepared DS-PL membranes significantly improved neo-vascularization, re-epithelialization and collagen formation as well as inhibited inflammatory reaction in the diabetic wound bed, which eventually stimulated the healing of the diabetic wound. Collectively, these results suggest that the combination of hierarchical structures (nanopores on the aligned fibers) with the controllable released DMOG drugs as well as Si ions from the membranes, which could create a synergetic effect on the rapid stimulation of angiogenesis in the diabetic wound bed, is a potential novel therapeutic strategy for highly efficient diabetic wound healing. A chronic wound in diabetic patients is usually characterized by the poor angiogenesis and the delayed wound closure. The main innovation of this study is to design a new kind of skin tissue engineered scaffold, aligned porous poly (l-lactic acid) (PlLA) electrospun

  5. DNA-based watermarks using the DNA-Crypt algorithm

    Directory of Open Access Journals (Sweden)

    Barnekow Angelika

    2007-05-01

    Full Text Available Abstract Background The aim of this paper is to demonstrate the application of watermarks based on DNA sequences to identify the unauthorized use of genetically modified organisms (GMOs protected by patents. Predicted mutations in the genome can be corrected by the DNA-Crypt program leaving the encrypted information intact. Existing DNA cryptographic and steganographic algorithms use synthetic DNA sequences to store binary information however, although these sequences can be used for authentication, they may change the target DNA sequence when introduced into living organisms. Results The DNA-Crypt algorithm and image steganography are based on the same watermark-hiding principle, namely using the least significant base in case of DNA-Crypt and the least significant bit in case of the image steganography. It can be combined with binary encryption algorithms like AES, RSA or Blowfish. DNA-Crypt is able to correct mutations in the target DNA with several mutation correction codes such as the Hamming-code or the WDH-code. Mutations which can occur infrequently may destroy the encrypted information, however an integrated fuzzy controller decides on a set of heuristics based on three input dimensions, and recommends whether or not to use a correction code. These three input dimensions are the length of the sequence, the individual mutation rate and the stability over time, which is represented by the number of generations. In silico experiments using the Ypt7 in Saccharomyces cerevisiae shows that the DNA watermarks produced by DNA-Crypt do not alter the translation of mRNA into protein. Conclusion The program is able to store watermarks in living organisms and can maintain the original information by correcting mutations itself. Pairwise or multiple sequence alignments show that DNA-Crypt produces few mismatches between the sequences similar to all steganographic algorithms.

  6. DNA-based watermarks using the DNA-Crypt algorithm.

    Science.gov (United States)

    Heider, Dominik; Barnekow, Angelika

    2007-05-29

    The aim of this paper is to demonstrate the application of watermarks based on DNA sequences to identify the unauthorized use of genetically modified organisms (GMOs) protected by patents. Predicted mutations in the genome can be corrected by the DNA-Crypt program leaving the encrypted information intact. Existing DNA cryptographic and steganographic algorithms use synthetic DNA sequences to store binary information however, although these sequences can be used for authentication, they may change the target DNA sequence when introduced into living organisms. The DNA-Crypt algorithm and image steganography are based on the same watermark-hiding principle, namely using the least significant base in case of DNA-Crypt and the least significant bit in case of the image steganography. It can be combined with binary encryption algorithms like AES, RSA or Blowfish. DNA-Crypt is able to correct mutations in the target DNA with several mutation correction codes such as the Hamming-code or the WDH-code. Mutations which can occur infrequently may destroy the encrypted information, however an integrated fuzzy controller decides on a set of heuristics based on three input dimensions, and recommends whether or not to use a correction code. These three input dimensions are the length of the sequence, the individual mutation rate and the stability over time, which is represented by the number of generations. In silico experiments using the Ypt7 in Saccharomyces cerevisiae shows that the DNA watermarks produced by DNA-Crypt do not alter the translation of mRNA into protein. The program is able to store watermarks in living organisms and can maintain the original information by correcting mutations itself. Pairwise or multiple sequence alignments show that DNA-Crypt produces few mismatches between the sequences similar to all steganographic algorithms.

  7. DNA-based watermarks using the DNA-Crypt algorithm

    Science.gov (United States)

    Heider, Dominik; Barnekow, Angelika

    2007-01-01

    Background The aim of this paper is to demonstrate the application of watermarks based on DNA sequences to identify the unauthorized use of genetically modified organisms (GMOs) protected by patents. Predicted mutations in the genome can be corrected by the DNA-Crypt program leaving the encrypted information intact. Existing DNA cryptographic and steganographic algorithms use synthetic DNA sequences to store binary information however, although these sequences can be used for authentication, they may change the target DNA sequence when introduced into living organisms. Results The DNA-Crypt algorithm and image steganography are based on the same watermark-hiding principle, namely using the least significant base in case of DNA-Crypt and the least significant bit in case of the image steganography. It can be combined with binary encryption algorithms like AES, RSA or Blowfish. DNA-Crypt is able to correct mutations in the target DNA with several mutation correction codes such as the Hamming-code or the WDH-code. Mutations which can occur infrequently may destroy the encrypted information, however an integrated fuzzy controller decides on a set of heuristics based on three input dimensions, and recommends whether or not to use a correction code. These three input dimensions are the length of the sequence, the individual mutation rate and the stability over time, which is represented by the number of generations. In silico experiments using the Ypt7 in Saccharomyces cerevisiae shows that the DNA watermarks produced by DNA-Crypt do not alter the translation of mRNA into protein. Conclusion The program is able to store watermarks in living organisms and can maintain the original information by correcting mutations itself. Pairwise or multiple sequence alignments show that DNA-Crypt produces few mismatches between the sequences similar to all steganographic algorithms. PMID:17535434

  8. Saccharomyces boulardii improves humoral immune response to DNA vaccines against leptospirosis.

    Science.gov (United States)

    Silveira, Marcelle Moura; Conceição, Fabricio Rochedo; Mendonça, Marcelo; Moreira, Gustavo Marçal Schmidt Garcia; Da Cunha, Carlos Eduardo Pouey; Conrad, Neida Lucia; Oliveira, Patrícia Diaz de; Hartwig, Daiane Drawanz; De Leon, Priscila Marques Moura; Moreira, Ângela Nunes

    2017-02-01

    Saccharomyces boulardii may improve the immune response by enhancing the production of anti-inflammatory cytokines, T-cell proliferation and dendritic cell activation. The immunomodulator effect of this probiotic has never been tested with DNA vaccines, which frequently induce low antibody titers. This study evaluated the capacity of Saccharomyces boulardii to improve the humoral and cellular immune responses using DNA vaccines coding for the leptospiral protein fragments LigAni and LigBrep. BALB/c mice were fed with rodent-specific feed containing 108 c.f.u. of Saccharomycesboulardii per gram. Animals were immunized three times intramuscularly with 100 µg of pTARGET plasmids containing the coding sequences for the above mentioned proteins. Antibody titers were measured by indirect ELISA. Expression levels of IL-4, IL-10, IL-12, IL-17, IFN-γ and TGF-β were determined by quantitative real-time PCR from RNA extracted from whole blood, after an intraperitoneal boost with 50 µg of the recombinant proteins.Results/Key findings. Antibody titers increased significantly after the second and third application when pTARGET/ligAni and pTARGET/ligBrep were used to vaccinate the animals in comparison with the control group (PSaccharomyces boulardii. The results suggested that Saccharomyces boulardii has an immunomodulator effect in DNA vaccines, mainly by stimulating the humoral response, which is often limited in this kind of vaccine. Therefore, the use of Saccharomyces boulardii as immunomodulator represents a new alternative strategy for more efficient DNA vaccination.

  9. Effect of grain alignment on interface trap density of thermally oxidized aligned-crystalline silicon films

    Science.gov (United States)

    Choi, Woong; Lee, Jung-Kun; Findikoglu, Alp T.

    2006-12-01

    The authors report studies of the effect of grain alignment on interface trap density of thermally oxidized aligned-crystalline silicon (ACSi) films by means of capacitance-voltage (C-V) measurements. C-V curves were measured on metal-oxide-semiconductor (MOS) capacitors fabricated on ⟨001⟩-oriented ACSi films on polycrystalline substrates. From high-frequency C-V curves, the authors calculated a decrease of interface trap density from 2×1012to1×1011cm-2eV-1 as the grain mosaic spread in ACSi films improved from 13.7° to 6.5°. These results demonstrate the effectiveness of grain alignment as a process technique to achieve significantly enhanced performance in small-grained (⩽1μm ) polycrystalline Si MOS-type devices.

  10. Isolation of full-length putative rat lysophospholipase cDNA using improved methods for mRNA isolation and cDNA cloning

    International Nuclear Information System (INIS)

    Han, J.H.; Stratowa, C.; Rutter, W.J.

    1987-01-01

    The authors have cloned a full-length putative rat pancreatic lysophospholipase cDNA by an improved mRNA isolation method and cDNA cloning strategy using [ 32 P]-labelled nucleotides. These new methods allow the construction of a cDNA library from the adult rat pancreas in which the majority of recombinant clones contained complete sequences for the corresponding mRNAs. A previously recognized but unidentified long and relatively rare cDNA clone containing the entire sequence from the cap site at the 5' end to the poly(A) tail at the 3' end of the mRNA was isolated by single-step screening of the library. The size, amino acid composition, and the activity of the protein expressed in heterologous cells strongly suggest this mRNA codes for lysophospholipase

  11. GraphAlignment: Bayesian pairwise alignment of biological networks

    Directory of Open Access Journals (Sweden)

    Kolář Michal

    2012-11-01

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

  12. Laser alignment of rotating equipment at PNL

    International Nuclear Information System (INIS)

    Berndt, R.H.

    1994-05-01

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

  13. Combining bleach and mild predigestion improves ancient DNA recovery from bones

    DEFF Research Database (Denmark)

    Boessenkool, Sanne; Hanghøj, Kristian Ebbesen; Nistelberger, Heidi M.

    2017-01-01

    library characteristics, such as DNA damage profiles or the composition of microbial communities, are little affected by the pre-extraction protocols. Application of the combined protocol presented in this study will facilitate the genetic analysis of an increasing number of ancient remains...... aimed to improve ancient DNA recovery before library amplification have recently been developed. Here, we test the effects of combining two of such protocols, a bleach wash and a predigestion step, on 12 bone samples of Atlantic cod and domestic horse aged 750-1350 cal. years before present. Using high...

  14. Improving nuclear plant management effectiveness: Aligning strategy, systems, and people

    International Nuclear Information System (INIS)

    Price, K.F.

    1991-01-01

    The effectiveness of any organization requires alignment of the appropriate financial, physical, and human resources. The manager's role is to efficiently utilize the right combination of these resources to achieve organizational objectives. In-depth studies of the nuclear programs of three major investor-owned utilities using a culture assessment process called the communication, values, and rewards (CVR) assessment have shown significant misalignments in those organizations' strategies, systems and people management. The CVR assessment related employees' perceptions of what drives their company's culture with the stated company strategic direction and management philosophies. Specifically, CVR provides a comparison of employee-held work-related values with those desired by management. Data obtained by a CVR assessment can be used to understand organizational misalignment and make changes to bring systems into alignment with corporate strategy and culture

  15. A Kalman Filter for SINS Self-Alignment Based on Vector Observation.

    Science.gov (United States)

    Xu, Xiang; Xu, Xiaosu; Zhang, Tao; Li, Yao; Tong, Jinwu

    2017-01-29

    In this paper, a self-alignment method for strapdown inertial navigation systems based on the q -method is studied. In addition, an improved method based on integrating gravitational apparent motion to form apparent velocity is designed, which can reduce the random noises of the observation vectors. For further analysis, a novel self-alignment method using a Kalman filter based on adaptive filter technology is proposed, which transforms the self-alignment procedure into an attitude estimation using the observation vectors. In the proposed method, a linear psuedo-measurement equation is adopted by employing the transfer method between the quaternion and the observation vectors. Analysis and simulation indicate that the accuracy of the self-alignment is improved. Meanwhile, to improve the convergence rate of the proposed method, a new method based on parameter recognition and a reconstruction algorithm for apparent gravitation is devised, which can reduce the influence of the random noises of the observation vectors. Simulations and turntable tests are carried out, and the results indicate that the proposed method can acquire sound alignment results with lower standard variances, and can obtain higher alignment accuracy and a faster convergence rate.

  16. Improved DNA condensation, stability, and transfection with alkyl sulfonyl-functionalized PAMAM G2

    Energy Technology Data Exchange (ETDEWEB)

    Rata-Aguilar, Azahara, E-mail: azahara@ugr.es; Maldonado-Valderrama, Julia; Jódar-Reyes, Ana Belén; Ortega-Vinuesa, Juan Luis [University of Granada, Biocolloid and Fluid Physics Group, Department of Applied Physics (Spain); Santoyo-Gonzalez, Francisco [University of Granada, Organic Chemistry Department, Institute of Biotechnology (Spain); Martín-Rodríguez, Antonio [University of Granada, Biocolloid and Fluid Physics Group, Department of Applied Physics (Spain)

    2015-04-15

    In this work, we have used a second-generation PAMAM grafted with octadecyl sulfonyl chains to condense plasmid DNA. The influence of this modification at different levels was investigated by comparison with original PAMAM G2. The condensation process and temporal stability of the complexes was studied with DLS, finding that the aliphatic chains influence DNA compaction via hydrophobic forces and markedly improve the formation and temporal stability of a single populated system with a hydrodynamic diameter below 100 nm. Interaction with a cell membrane model was also evaluated with a pendant drop tensiometer, resulting in further incorporation of the C18-PAMAM dendriplexes onto the interface. The improvement observed in transfection with our C18 grafted PAMAM is ascribed to the size, stability, and interfacial behavior of the complexes, which in turn are consequence of the DNA condensation process and the interactions involved.

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

    Directory of Open Access Journals (Sweden)

    Richard Wilton

    2015-03-01

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

  18. Unscented Kalman filter for SINS alignment

    Institute of Scientific and Technical Information of China (English)

    Zhou Zhanxin; Gao Yanan; Chen Jiabin

    2007-01-01

    In order to improve the filter accuracy for the nonlinear error model of strapdown inertial navigation system (SINS) alignment, Unscented Kalman Filter (UKF) is presented for simulation with stationary base and moving base of SINS alignment.Simulation results show the superior performance of this approach when compared with classical suboptimal techniques such as extended Kalman filter in cases of large initial misalignment.The UKF has good performance in case of small initial misalignment.

  19. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez.

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

  20. Spatiotemporal alignment of in utero BOLD-MRI series.

    Science.gov (United States)

    Turk, Esra Abaci; Luo, Jie; Gagoski, Borjan; Pascau, Javier; Bibbo, Carolina; Robinson, Julian N; Grant, P Ellen; Adalsteinsson, Elfar; Golland, Polina; Malpica, Norberto

    2017-08-01

    To present a method for spatiotemporal alignment of in-utero magnetic resonance imaging (MRI) time series acquired during maternal hyperoxia for enabling improved quantitative tracking of blood oxygen level-dependent (BOLD) signal changes that characterize oxygen transport through the placenta to fetal organs. The proposed pipeline for spatiotemporal alignment of images acquired with a single-shot gradient echo echo-planar imaging includes 1) signal nonuniformity correction, 2) intravolume motion correction based on nonrigid registration, 3) correction of motion and nonrigid deformations across volumes, and 4) detection of the outlier volumes to be discarded from subsequent analysis. BOLD MRI time series collected from 10 pregnant women during 3T scans were analyzed using this pipeline. To assess pipeline performance, signal fluctuations between consecutive timepoints were examined. In addition, volume overlap and distance between manual region of interest (ROI) delineations in a subset of frames and the delineations obtained through propagation of the ROIs from the reference frame were used to quantify alignment accuracy. A previously demonstrated rigid registration approach was used for comparison. The proposed pipeline improved anatomical alignment of placenta and fetal organs over the state-of-the-art rigid motion correction methods. In particular, unexpected temporal signal fluctuations during the first normoxia period were significantly decreased (P quantitative studies of placental function by improving spatiotemporal alignment across placenta and fetal organs. 1 Technical Efficacy: Stage 1 J. MAGN. RESON. IMAGING 2017;46:403-412. © 2017 International Society for Magnetic Resonance in Medicine.

  1. THE ATLAS INNER DETECTOR TRACK BASED ALIGNMENT

    CERN Document Server

    Marti i Garcia, Salvador; The ATLAS collaboration

    2018-01-01

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

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

    Science.gov (United States)

    Kawata, Masaaki; Sato, Chikara

    2007-06-01

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

  3. W-curve alignments for HIV-1 genomic comparisons.

    Directory of Open Access Journals (Sweden)

    Douglas J Cork

    2010-06-01

    Full Text Available The W-curve was originally developed as a graphical visualization technique for viewing DNA and RNA sequences. Its ability to render features of DNA also makes it suitable for computational studies. Its main advantage in this area is utilizing a single-pass algorithm for comparing the sequences. Avoiding recursion during sequence alignments offers advantages for speed and in-process resources. The graphical technique also allows for multiple models of comparison to be used depending on the nucleotide patterns embedded in similar whole genomic sequences. The W-curve approach allows us to compare large numbers of samples quickly.We are currently tuning the algorithm to accommodate quirks specific to HIV-1 genomic sequences so that it can be used to aid in diagnostic and vaccine efforts. Tracking the molecular evolution of the virus has been greatly hampered by gap associated problems predominantly embedded within the envelope gene of the virus. Gaps and hypermutation of the virus slow conventional string based alignments of the whole genome. This paper describes the W-curve algorithm itself, and how we have adapted it for comparison of similar HIV-1 genomes. A treebuilding method is developed with the W-curve that utilizes a novel Cylindrical Coordinate distance method and gap analysis method. HIV-1 C2-V5 env sequence regions from a Mother/Infant cohort study are used in the comparison.The output distance matrix and neighbor results produced by the W-curve are functionally equivalent to those from Clustal for C2-V5 sequences in the mother/infant pairs infected with CRF01_AE.Significant potential exists for utilizing this method in place of conventional string based alignment of HIV-1 genomes, such as Clustal X. With W-curve heuristic alignment, it may be possible to obtain clinically useful results in a short time-short enough to affect clinical choices for acute treatment. A description of the W-curve generation process, including a comparison

  4. W-curve alignments for HIV-1 genomic comparisons.

    Science.gov (United States)

    Cork, Douglas J; Lembark, Steven; Tovanabutra, Sodsai; Robb, Merlin L; Kim, Jerome H

    2010-06-01

    The W-curve was originally developed as a graphical visualization technique for viewing DNA and RNA sequences. Its ability to render features of DNA also makes it suitable for computational studies. Its main advantage in this area is utilizing a single-pass algorithm for comparing the sequences. Avoiding recursion during sequence alignments offers advantages for speed and in-process resources. The graphical technique also allows for multiple models of comparison to be used depending on the nucleotide patterns embedded in similar whole genomic sequences. The W-curve approach allows us to compare large numbers of samples quickly. We are currently tuning the algorithm to accommodate quirks specific to HIV-1 genomic sequences so that it can be used to aid in diagnostic and vaccine efforts. Tracking the molecular evolution of the virus has been greatly hampered by gap associated problems predominantly embedded within the envelope gene of the virus. Gaps and hypermutation of the virus slow conventional string based alignments of the whole genome. This paper describes the W-curve algorithm itself, and how we have adapted it for comparison of similar HIV-1 genomes. A treebuilding method is developed with the W-curve that utilizes a novel Cylindrical Coordinate distance method and gap analysis method. HIV-1 C2-V5 env sequence regions from a Mother/Infant cohort study are used in the comparison. The output distance matrix and neighbor results produced by the W-curve are functionally equivalent to those from Clustal for C2-V5 sequences in the mother/infant pairs infected with CRF01_AE. Significant potential exists for utilizing this method in place of conventional string based alignment of HIV-1 genomes, such as Clustal X. With W-curve heuristic alignment, it may be possible to obtain clinically useful results in a short time-short enough to affect clinical choices for acute treatment. A description of the W-curve generation process, including a comparison technique of

  5. Alignment methods: strategies, challenges, benchmarking, and comparative overview.

    Science.gov (United States)

    Löytynoja, Ari

    2012-01-01

    Comparative evolutionary analyses of molecular sequences are solely based on the identities and differences detected between homologous characters. Errors in this homology statement, that is errors in the alignment of the sequences, are likely to lead to errors in the downstream analyses. Sequence alignment and phylogenetic inference are tightly connected and many popular alignment programs use the phylogeny to divide the alignment problem into smaller tasks. They then neglect the phylogenetic tree, however, and produce alignments that are not evolutionarily meaningful. The use of phylogeny-aware methods reduces the error but the resulting alignments, with evolutionarily correct representation of homology, can challenge the existing practices and methods for viewing and visualising the sequences. The inter-dependency of alignment and phylogeny can be resolved by joint estimation of the two; methods based on statistical models allow for inferring the alignment parameters from the data and correctly take into account the uncertainty of the solution but remain computationally challenging. Widely used alignment methods are based on heuristic algorithms and unlikely to find globally optimal solutions. The whole concept of one correct alignment for the sequences is questionable, however, as there typically exist vast numbers of alternative, roughly equally good alignments that should also be considered. This uncertainty is hidden by many popular alignment programs and is rarely correctly taken into account in the downstream analyses. The quest for finding and improving the alignment solution is complicated by the lack of suitable measures of alignment goodness. The difficulty of comparing alternative solutions also affects benchmarks of alignment methods and the results strongly depend on the measure used. As the effects of alignment error cannot be predicted, comparing the alignments' performance in downstream analyses is recommended.

  6. The Modular Construction of DNA Double Helix

    Indian Academy of Sciences (India)

    discovery, DNA structure has been able to disseminate knowl- edge of key ... band a. This procedure would place segment a, overlapping with d. Glue securely a ... Because of alignment problems, unless great care is taken, the modules do ...

  7. Optimal Nonlinear Filter for INS Alignment

    Institute of Scientific and Technical Information of China (English)

    赵瑞; 顾启泰

    2002-01-01

    All the methods to handle the inertial navigation system (INS) alignment were sub-optimal in the past. In this paper, particle filtering (PF) as an optimal method is used for solving the problem of INS alignment. A sub-optimal two-step filtering algorithm is presented to improve the real-time performance of PF. The approach combines particle filtering with Kalman filtering (KF). Simulation results illustrate the superior performance of these approaches when compared with extended Kalman filtering (EKF).

  8. Prophagic DNA Fragments in Streptococcus agalactiae Strains and Association with Neonatal Meningitis

    Science.gov (United States)

    van der Mee-Marquet, Nathalie; Domelier, Anne-Sophie; Mereghetti, Laurent; Lanotte, Philippe; Rosenau, Agnès; van Leeuwen, Willem; Quentin, Roland

    2006-01-01

    We identified—by randomly amplified polymorphic DNA (RAPD) analysis at the population level followed by DNA differential display, cloning, and sequencing—three prophage DNA fragments (F5, F7, and F10) in Streptococcus agalactiae that displayed significant sequence similarity to the DNA of S. agalactiae and Streptococcus pyogenes. The F5 sequence aligned with a prophagic gene encoding the large subunit of a terminase, F7 aligned with a phage-associated cell wall hydrolase and a phage-associated lysin, and F10 aligned with a transcriptional regulator (ArpU family) and a phage-associated endonuclease. We first determined the prevalence of F5, F7, and F10 by PCR in a collection of 109 strains isolated in the 1980s and divided into two populations: one with a high risk of causing meningitis (HR group) and the other with a lower risk of causing meningitis (LR group). These fragments were significantly more prevalent in the HR group than in the LR group (P S. agalactiae strains to invade the neonatal brain endothelium. We then determined the prevalence of F5, F7, and F10 by PCR in a collection of 40 strains recently isolated from neonatal meningitis cases for comparison with the cerebrospinal fluid (CSF) strains isolated in the 1980s. The prevalence of the three prophage DNA fragments was similar in these two populations isolated 15 years apart. We suggest that the prophage DNA fragments identified have remained stable in many CSF S. agalactiae strains, possibly due to their importance in virulence or fitness. PMID:16517893

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

    Science.gov (United States)

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

    2015-01-01

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

  10. Moving State Marine SINS Initial Alignment Based on High Degree CKF

    Directory of Open Access Journals (Sweden)

    Yong-Gang Zhang

    2014-01-01

    Full Text Available A new moving state marine initial alignment method of strap-down inertial navigation system (SINS is proposed based on high-degree cubature Kalman filter (CKF, which can capture higher order Taylor expansion terms of nonlinear alignment model than the existing third-degree CKF, unscented Kalman filter and central difference Kalman filter, and improve the accuracy of initial alignment under large heading misalignment angle condition. Simulation results show the efficiency and advantage of the proposed initial alignment method as compared with existing initial alignment methods for the moving state SINS initial alignment with large heading misalignment angle.

  11. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez

    2010-01-01

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

  12. Heuristics for multiobjective multiple sequence alignment.

    Science.gov (United States)

    Abbasi, Maryam; Paquete, Luís; Pereira, Francisco B

    2016-07-15

    Aligning multiple sequences arises in many tasks in Bioinformatics. However, the alignments produced by the current software packages are highly dependent on the parameters setting, such as the relative importance of opening gaps with respect to the increase of similarity. Choosing only one parameter setting may provide an undesirable bias in further steps of the analysis and give too simplistic interpretations. In this work, we reformulate multiple sequence alignment from a multiobjective point of view. The goal is to generate several sequence alignments that represent a trade-off between maximizing the substitution score and minimizing the number of indels/gaps in the sum-of-pairs score function. This trade-off gives to the practitioner further information about the similarity of the sequences, from which she could analyse and choose the most plausible alignment. We introduce several heuristic approaches, based on local search procedures, that compute a set of sequence alignments, which are representative of the trade-off between the two objectives (substitution score and indels). Several algorithm design options are discussed and analysed, with particular emphasis on the influence of the starting alignment and neighborhood search definitions on the overall performance. A perturbation technique is proposed to improve the local search, which provides a wide range of high-quality alignments. The proposed approach is tested experimentally on a wide range of instances. We performed several experiments with sequences obtained from the benchmark database BAliBASE 3.0. To evaluate the quality of the results, we calculate the hypervolume indicator of the set of score vectors returned by the algorithms. The results obtained allow us to identify reasonably good choices of parameters for our approach. Further, we compared our method in terms of correctly aligned pairs ratio and columns correctly aligned ratio with respect to reference alignments. Experimental results show

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

    International Nuclear Information System (INIS)

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

    2016-01-01

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

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

    Energy Technology Data Exchange (ETDEWEB)

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

    2016-05-01

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

  15. Optimizing hyaluronidase dose and plasmid DNA delivery greatly improves gene electrotransfer efficiency in rat skeletal muscle

    DEFF Research Database (Denmark)

    Åkerström, Thorbjörn; Vedel, Kenneth; Needham Andersen, Josefine

    2015-01-01

    Transfection of rat skeletal muscle in vivo is a widely used research model. However, gene electrotransfer protocols have been developed for mice and yield variable results in rats. We investigated whether changes in hyaluronidase pre-treatment and plasmid DNA delivery can improve transfection...... with a homogenous distribution. We also show that transfection was stable over five weeks of regular exercise or inactivity. Our findings show that species-specific plasmid DNA delivery and hyaluronidase pre-treatment greatly improves transfection efficiency in rat skeletal muscle....... efficiency in rat skeletal muscle. We found that pre-treating the muscle with a hyaluronidase dose suitable for rats (0.56. U/g b.w.) prior to plasmid DNA injection increased transfection efficiency by >200% whereas timing of the pre-treatment did not affect efficiency. Uniformly distributing plasmid DNA...

  16. Comparative d2/d3 LSU–rDNA sequence study of some Iranian ...

    African Journals Online (AJOL)

    SERVER

    2007-11-05

    Nov 5, 2007 ... segments yielded one fragment at over all sequenced isolates as 787 bp in size. The DNA sequences were aligned .... expansion segments of the 28S rDNA subunit (D2/D3. LSU-rDNA) are the ... isolated from different geographical location from tea shrubs infested roots of Guilan province, Iran (Table 1).

  17. Improvement in the amine glass platform by bubbling method for a DNA microarray

    Directory of Open Access Journals (Sweden)

    Jee SH

    2015-10-01

    Full Text Available Seung Hyun Jee,1 Jong Won Kim,2 Ji Hyeong Lee,2 Young Soo Yoon11Department of Chemical and Biological Engineering, Gachon University, Seongnam, Gyeonggi, Republic of Korea; 2Genomics Clinical Research Institute, LabGenomics Co., Ltd., Bundang-gu, Seongnam-si, Gyeonggi-do, Republic of KoreaAbstract: A glass platform with high sensitivity for sexually transmitted diseases microarray is described here. An amino-silane-based self-assembled monolayer was coated on the surface of a glass platform using a novel bubbling method. The optimized surface of the glass platform had highly uniform surface modifications using this method, as well as improved hybridization properties with capture probes in the DNA microarray. On the basis of these results, the improved glass platform serves as a highly reliable and optimal material for the DNA microarray. Moreover, in this study, we demonstrated that our glass platform, manufactured by utilizing the bubbling method, had higher uniformity, shorter processing time, lower background signal, and higher spot signal than the platforms manufactured by the general dipping method. The DNA microarray manufactured with a glass platform prepared using bubbling method can be used as a clinical diagnostic tool. Keywords: DNA microarray, glass platform, bubbling method, self-assambled monolayer

  18. An Improved Method for High Quality Metagenomics DNA Extraction from Human and Environmental Samples

    DEFF Research Database (Denmark)

    Bag, Satyabrata; Saha, Bipasa; Mehta, Ojasvi

    2016-01-01

    and human origin samples. We introduced a combination of physical, chemical and mechanical lysis methods for proper lysis of microbial inhabitants. The community microbial DNA was precipitated by using salt and organic solvent. Both the quality and quantity of isolated DNA was compared with the existing...... methodologies and the supremacy of our method was confirmed. Maximum recovery of genomic DNA in the absence of substantial amount of impurities made the method convenient for nucleic acid extraction. The nucleic acids obtained using this method are suitable for different downstream applications. This improved...

  19. Overexpression of DNA ligase III in mitochondria protects cells against oxidative stress and improves mitochondrial DNA base excision repair

    DEFF Research Database (Denmark)

    Akbari, Mansour; Keijzers, Guido; Maynard, Scott

    2014-01-01

    slower than the preceding mitochondrial BER steps. Overexpression of DNA ligase III in mitochondria improved the rate of overall BER, increased cell survival after menadione induced oxidative stress and reduced autophagy following the inhibition of the mitochondrial electron transport chain complex I...

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

    International Nuclear Information System (INIS)

    Gauntt, David M.; Barnes, Gary T.

    2010-01-01

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

  1. Alignment of Human Resource Practices and Teacher Performance Competency

    Science.gov (United States)

    Heneman III, Herbert G.; Milanowski, Anthony T.

    2004-01-01

    In this article, we argue that human resource (HR) management practices are important components of strategies for improving student achievement in an accountability environment. We present a framework illustrating the alignment of educational HR management practices to a teacher performance competency model, which in turn is aligned with student…

  2. Introducing improved structural properties and salt dependence into a coarse-grained model of DNA

    Energy Technology Data Exchange (ETDEWEB)

    Snodin, Benedict E. K., E-mail: benedict.snodin@chem.ox.ac.uk; Mosayebi, Majid; Schreck, John S.; Romano, Flavio; Doye, Jonathan P. K., E-mail: jonathan.doye@chem.ox.ac.uk [Physical and Theoretical Chemistry Laboratory, Department of Chemistry, University of Oxford, South Parks Road, Oxford OX1 3QZ (United Kingdom); Randisi, Ferdinando [Life Sciences Interface Doctoral Training Center, South Parks Road, Oxford OX1 3QU (United Kingdom); Rudolf Peierls Centre for Theoretical Physics, 1 Keble Road, Oxford OX1 3NP (United Kingdom); Šulc, Petr [Center for Studies in Physics and Biology, The Rockefeller University, 1230 York Avenue, New York, New York 10065 (United States); Ouldridge, Thomas E. [Department of Mathematics, Imperial College, 180 Queen’s Gate, London SW7 2AZ (United Kingdom); Tsukanov, Roman; Nir, Eyal [Department of Chemistry and the Ilse Katz Institute for Nanoscale Science and Technology, Ben-Gurion University of the Negev, Beer Sheva (Israel); Louis, Ard A. [Rudolf Peierls Centre for Theoretical Physics, 1 Keble Road, Oxford OX1 3NP (United Kingdom)

    2015-06-21

    We introduce an extended version of oxDNA, a coarse-grained model of deoxyribonucleic acid (DNA) designed to capture the thermodynamic, structural, and mechanical properties of single- and double-stranded DNA. By including explicit major and minor grooves and by slightly modifying the coaxial stacking and backbone-backbone interactions, we improve the ability of the model to treat large (kilobase-pair) structures, such as DNA origami, which are sensitive to these geometric features. Further, we extend the model, which was previously parameterised to just one salt concentration ([Na{sup +}] = 0.5M), so that it can be used for a range of salt concentrations including those corresponding to physiological conditions. Finally, we use new experimental data to parameterise the oxDNA potential so that consecutive adenine bases stack with a different strength to consecutive thymine bases, a feature which allows a more accurate treatment of systems where the flexibility of single-stranded regions is important. We illustrate the new possibilities opened up by the updated model, oxDNA2, by presenting results from simulations of the structure of large DNA objects and by using the model to investigate some salt-dependent properties of DNA.

  3. Introducing improved structural properties and salt dependence into a coarse-grained model of DNA

    International Nuclear Information System (INIS)

    Snodin, Benedict E. K.; Mosayebi, Majid; Schreck, John S.; Romano, Flavio; Doye, Jonathan P. K.; Randisi, Ferdinando; Šulc, Petr; Ouldridge, Thomas E.; Tsukanov, Roman; Nir, Eyal; Louis, Ard A.

    2015-01-01

    We introduce an extended version of oxDNA, a coarse-grained model of deoxyribonucleic acid (DNA) designed to capture the thermodynamic, structural, and mechanical properties of single- and double-stranded DNA. By including explicit major and minor grooves and by slightly modifying the coaxial stacking and backbone-backbone interactions, we improve the ability of the model to treat large (kilobase-pair) structures, such as DNA origami, which are sensitive to these geometric features. Further, we extend the model, which was previously parameterised to just one salt concentration ([Na + ] = 0.5M), so that it can be used for a range of salt concentrations including those corresponding to physiological conditions. Finally, we use new experimental data to parameterise the oxDNA potential so that consecutive adenine bases stack with a different strength to consecutive thymine bases, a feature which allows a more accurate treatment of systems where the flexibility of single-stranded regions is important. We illustrate the new possibilities opened up by the updated model, oxDNA2, by presenting results from simulations of the structure of large DNA objects and by using the model to investigate some salt-dependent properties of DNA

  4. Stochastic sampling of the RNA structural alignment space.

    Science.gov (United States)

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

    2009-07-01

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

  5. Resolution-improved in situ DNA hybridization detection based on microwave photonic interrogation.

    Science.gov (United States)

    Cao, Yuan; Guo, Tuan; Wang, Xudong; Sun, Dandan; Ran, Yang; Feng, Xinhuan; Guan, Bai-ou

    2015-10-19

    In situ bio-sensing system based on microwave photonics filter (MPF) interrogation method with improved resolution is proposed and experimentally demonstrated. A microfiber Bragg grating (mFBG) is used as sensing probe for DNA hybridization detection. Different from the traditional wavelength monitoring technique, we use the frequency interrogation scheme for resolution-improved bio-sensing detection. Experimental results show that the frequency shift of MPF notch presents a linear response to the surrounding refractive index (SRI) change over the range of 1.33 to 1.38, with a SRI resolution up to 2.6 × 10(-5) RIU, which has been increased for almost two orders of magnitude compared with the traditional fundamental mode monitoring technique (~3.6 × 10(-3) RIU). Due to the high Q value (about 27), the whole process of DNA hybridization can be in situ monitored. The proposed MPF-based bio-sensing system provides a new interrogation method over the frequency domain with improved sensing resolution and rapid interrogation rate for biochemical and environmental measurement.

  6. Modification of Kolmogorov-Smirnov test for DNA content data analysis through distribution alignment.

    Science.gov (United States)

    Huang, Shuguang; Yeo, Adeline A; Li, Shuyu Dan

    2007-10-01

    The Kolmogorov-Smirnov (K-S) test is a statistical method often used for comparing two distributions. In high-throughput screening (HTS) studies, such distributions usually arise from the phenotype of independent cell populations. However, the K-S test has been criticized for being overly sensitive in applications, and it often detects a statistically significant difference that is not biologically meaningful. One major reason is that there is a common phenomenon in HTS studies that systematic drifting exists among the distributions due to reasons such as instrument variation, plate edge effect, accidental difference in sample handling, etc. In particular, in high-content cellular imaging experiments, the location shift could be dramatic since some compounds themselves are fluorescent. This oversensitivity of the K-S test is particularly overpowered in cellular assays where the sample sizes are very big (usually several thousands). In this paper, a modified K-S test is proposed to deal with the nonspecific location-shift problem in HTS studies. Specifically, we propose that the distributions are "normalized" by density curve alignment before the K-S test is conducted. In applications to simulation data and real experimental data, the results show that the proposed method has improved specificity.

  7. TREHALOSE-BASED ADDITIVE IMPROVED INTER-PRIMER BINDING SITE REACTIONS FOR DNA ISOLATED FROM RECALCITRANT PLANTS

    Directory of Open Access Journals (Sweden)

    Veronika Lancíková

    2014-02-01

    Full Text Available Trehalose-based (TBT-PAR additive was tested in order to optimize PCR amplification for DNA isolated from recalcitrant plants. Retrotransposon-based inter-primer binding site reactions were significantly improved with TBT-PAR solution using genomic DNA isolated from flax (Linum usitatissimum L., genotypes Kyivskyi, Bethune grown in radio-contaminated and non-radioactive remediated Chernobyl experimental fields. Additionally, similar improvements were observed using 19 recalcitrant genotypes of maize (Zea mays L. and three genotypes of yacon (Smallanthus sonchifolius, Poepp. et Endl., genotypes PER05, ECU45, BOL22 grown in standard field conditions.

  8. An Improved Methodology to Overcome Key Issues in Human Fecal Metagenomic DNA Extraction

    Directory of Open Access Journals (Sweden)

    Jitendra Kumar

    2016-12-01

    Full Text Available Microbes are ubiquitously distributed in nature, and recent culture-independent studies have highlighted the significance of gut microbiota in human health and disease. Fecal DNA is the primary source for the majority of human gut microbiome studies. However, further improvement is needed to obtain fecal metagenomic DNA with sufficient amount and good quality but low host genomic DNA contamination. In the current study, we demonstrate a quick, robust, unbiased, and cost-effective method for the isolation of high molecular weight (>23 kb metagenomic DNA (260/280 ratio >1.8 with a good yield (55.8 ± 3.8 ng/mg of feces. We also confirm that there is very low human genomic DNA contamination (eubacterial: human genomic DNA marker genes = 227.9:1 in the human feces. The newly-developed method robustly performs for fresh as well as stored fecal samples as demonstrated by 16S rRNA gene sequencing using 454 FLX+. Moreover, 16S rRNA gene analysis indicated that compared to other DNA extraction methods tested, the fecal metagenomic DNA isolated with current methodology retains species richness and does not show microbial diversity biases, which is further confirmed by qPCR with a known quantity of spike-in genomes. Overall, our data highlight a protocol with a balance between quality, amount, user-friendliness, and cost effectiveness for its suitability toward usage for culture-independent analysis of the human gut microbiome, which provides a robust solution to overcome key issues associated with fecal metagenomic DNA isolation in human gut microbiome studies.

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

    Science.gov (United States)

    Radu, Alex; Charleston, Michael

    2014-10-01

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

  10. Alignment of the drift tube detector at the neutrino oscillation experiment OPERA; Alignment des Driftroehrendetektors am Neutrino-Oszillationsexperiment OPERA

    Energy Technology Data Exchange (ETDEWEB)

    Goellnitz, Christoph

    2012-09-15

    The present thesis was composed during the course of the OPERA experiment, which aims to give a direct evidence for neutrino oscillations in the channel {nu}{sub {mu}} {yields} {nu}{sub {tau}}. The OPERA detector is designed to observe the appearance of tau neutrinos in an originally pure muon neutrino beam, the CNGS beam. As important part of the detector the precision tracker (PT), a drift tube detector, consists of 9504 drift tubes in 198 modules. In this thesis, several parts of the slow control of the PT are developed and implemented to ensure operation during data taking over several years. The main part is the geometric calibration, the alignment of the detector. The alignment procedure contains both hardware and software parts, the software methods are developed and applied. Using straight particle tracks, the detector components are geometrically corrected. A special challenge for the alignment for the PT is the fact that at this kind of low-rate experiment only a small number of particle tracks is available. With software-based corrections of the module rotation, a systematic error of 0.2 mrad has been attained, for corrections of translation, a systematic error of 32 {mu}m is reached. For the alignment between two adjacent PT walls, the statistical error is less than 8 {mu}m. All results of the position monitoring system are considered. All developed methods are tested with Monte Carlo simulations. The detector requirements ({Delta}p/p {<=} 0.25 below 25 GeV) are met. The analysis of the momentum measurement for high energies above 25 GeV demonstrates the resulting improvement. The mean momentum is falling significantly using the new alignment values. The significance of the detector alignment becomes most evident in the analysis of cosmic particles. The muon charge ratio R{sub {mu}} is expected not to be angular dependent. The {chi}{sup 2} probability of the measured distribution improves up to 58%. The muon charge ratio was also investigated in

  11. A Practical Guide to Multi-image Alignment

    OpenAIRE

    Aguerrebere, Cecilia; Delbracio, Mauricio; Bartesaghi, Alberto; Sapiro, Guillermo

    2018-01-01

    Multi-image alignment, bringing a group of images into common register, is an ubiquitous problem and the first step of many applications in a wide variety of domains. As a result, a great amount of effort is being invested in developing efficient multi-image alignment algorithms. Little has been done, however, to answer fundamental practical questions such as: what is the comparative performance of existing methods? is there still room for improvement? under which conditions should one techni...

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

    Energy Technology Data Exchange (ETDEWEB)

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

    2006-08-14

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

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

    Institute of Scientific and Technical Information of China (English)

    ZHOU Lizhong; Hideo Furuhashi; Yoshiyuki Uchida

    2001-01-01

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

  14. Improved fingercode alignment for accurate and compact fingerprint recognition

    CSIR Research Space (South Africa)

    Brown, Dane

    2016-05-01

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

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

    Energy Technology Data Exchange (ETDEWEB)

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

    2015-11-01

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

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

    Directory of Open Access Journals (Sweden)

    Kaufmann Michael

    2004-09-01

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

  17. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez and J. Pivarski

    2011-01-01

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

  18. Tracker Alignment Performance Plots after Commissioning

    CERN Document Server

    CMS Collaboration

    2017-01-01

    During the LHC shutdown in Winter 2016/17, the CMS pixel detector, the inner component of the CMS Tracker, was replaced by the Phase-1 upgrade detector. Among others improvements, the new pixel detector consists of four instead of three layers in the central barrel region (BPIX) and three instead of two disks in the endcap regions (FPIX). In this report, performance plots of pixel detector alignment results are presented, which were obtained with both cosmic-ray and pp collision data acquired at the beginning of the 2017 LHC operation. Alignment constants have been derived for each data-taking period to the level of single module positions in both the pixel and the strip detectors. The complete understanding of the alignment and biases was derived by using two algorithms, Millepede-II and HipPy. The results confirm each other.

  19. DNA Commission of the International Society for Forensic Genetics

    DEFF Research Database (Denmark)

    Parson, W; Gusmão, L; Hares, D R

    2014-01-01

    The DNA Commission of the International Society of Forensic Genetics (ISFG) regularly publishes guidelines and recommendations concerning the application of DNA polymorphisms to the question of human identification. Previous recommendations published in 2000 addressed the analysis and interpretat......The DNA Commission of the International Society of Forensic Genetics (ISFG) regularly publishes guidelines and recommendations concerning the application of DNA polymorphisms to the question of human identification. Previous recommendations published in 2000 addressed the analysis...... and interpretation of mitochondrial DNA (mtDNA) in forensic casework. While the foundations set forth in the earlier recommendations still apply, new approaches to the quality control, alignment and nomenclature of mitochondrial sequences, as well as the establishment of mtDNA reference population databases, have...... been developed. Here, we describe these developments and discuss their application to both mtDNA casework and mtDNA reference population databasing applications. While the generation of mtDNA for forensic casework has always been guided by specific standards, it is now well-established that data...

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

    International Nuclear Information System (INIS)

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

    2011-01-01

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

  1. Pairwise structure alignment specifically tuned for surface pockets and interaction interfaces

    KAUST Repository

    Cui, Xuefeng

    2015-09-09

    To detect and evaluate the similarities between the three-dimensional (3D) structures of two molecules, various kinds of methods have been proposed for the pairwise structure alignment problem [6, 9, 7, 11]. The problem plays important roles when studying the function and the evolution of biological molecules. Recently, pairwise structure alignment methods have been extended and applied on surface pocket structures [10, 3, 5] and interaction interface structures [8, 4]. The results show that, even when there are no global similarities discovered between the global sequences and the global structures, biological molecules or complexes could share similar functions because of well conserved pockets and interfaces. Thus, pairwise pocket and interface structure alignments are promising to unveil such shared functions that cannot be discovered by the well-studied global sequence and global structure alignments. State-of-the-art methods for pairwise pocket and interface structure alignments [4, 5] are direct extensions of the classic pairwise protein structure alignment methods, and thus such methods share a few limitations. First, the goal of the classic protein structure alignment methods is to align single-chain protein structures (i.e., a single fragment of residues connected by peptide bonds). However, we observed that pockets and interfaces tend to consist of tens of extremely short backbone fragments (i.e., three or fewer residues connected by peptide bonds). Thus, existing pocket and interface alignment methods based on the protein structure alignment methods still rely on the existence of long-enough backbone fragments, and the fragmentation issue of pockets and interfaces rises the risk of missing the optimal alignments. Moreover, existing interface structure alignment methods focus on protein-protein interfaces, and require a "blackbox preprocessing" before aligning protein-DNA and protein-RNA interfaces. Therefore, we introduce the PROtein STucture Alignment

  2. Genomic Mapping of Human DNA provides Evidence of Difference in Stretch between AT and GC rich regions

    Science.gov (United States)

    Reifenberger, Jeffrey; Dorfman, Kevin; Cao, Han

    Human DNA is a not a polymer consisting of a uniform distribution of all 4 nucleic acids, but rather contains regions of high AT and high GC content. When confined, these regions could have different stretch due to the extra hydrogen bond present in the GC basepair. To measure this potential difference, human genomic DNA was nicked with NtBspQI, labeled with a cy3 like fluorophore at the nick site, stained with YOYO, loaded into a device containing an array of nanochannels, and imaged. Over 473,000 individual molecules of DNA, corresponding to roughly 30x coverage of a human genome, were collected and aligned to the human reference. Based on the known AT/GC content between aligned pairs of labels, the stretch was measured for regions of similar size but different AT/GC content. We found that regions of high GC content were consistently more stretched than regions of high AT content between pairs of labels varying in size between 2.5 kbp and 500 kbp. We measured that for every 1% increase in GC content there was roughly a 0.06% increase in stretch. While this effect is small, it is important to take into account differences in stretch between AT and GC rich regions to improve the sensitivity of detection of structural variations from genomic variations. NIH Grant: R01-HG006851.

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

    Science.gov (United States)

    Suzuki, Hajime; Kasahara, Masahiro

    2018-02-19

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

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

    Directory of Open Access Journals (Sweden)

    Hartmann Stefanie

    2008-03-01

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

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

    Science.gov (United States)

    Hartmann, Stefanie; Vision, Todd J

    2008-03-26

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

  6. Technical improvement to prevent DNA degradation of Leptospira spp. in pulsed field gel electrophoresis.

    Science.gov (United States)

    Ribeiro, R L; Machry, L; Brazil, J M V; Ramos, T M V; Avelar, K E S; Pereira, M M

    2009-08-01

    Leptospirosis is a public health problem. Infection with pathogenic Leptospira occurs by exposure to many environments and is traditionally associated with occupational risk activities. Pulsed-field gel electrophoresis was used to investigate the epidemiological relatedness among Leptospira isolates. However, analysis by PFGE yielded inconclusive data as a result of extensive DNA degradation. This degradation can be significantly reduced by the inclusion of thiourea in the electrophoresis buffer, improving the analysis of DNA banding patterns.

  7. Fabrication and characterization of a solid-state nanopore with self-aligned carbon nanoelectrodes for molecular detection

    International Nuclear Information System (INIS)

    Spinney, Patrick S; Collins, Scott D; Smith, Rosemary L; Howitt, David G

    2012-01-01

    Stochastic molecular sensors based on resistive pulse nanopore modalities are envisioned as facile DNA sequencers. However, recent advances in nanotechnology fabrication have highlighted promising alternative detection mechanisms with higher sensitivity and potential single-base resolution. In this paper we present the novel self-aligned fabrication of a solid-state nanopore device with integrated transverse graphene-like carbon nanoelectrodes for polyelectrolyte molecular detection. The electrochemical transduction mechanism is characterized and found to result primarily from thermionic emission between the two transverse electrodes. Response of the nanopore to Lambda dsDNA and short (16-mer) ssDNA is demonstrated and distinguished. (paper)

  8. Nanostructured pillars based on vertically aligned carbon nanotubes as the stationary phase in micro-CEC.

    Science.gov (United States)

    Wu, Ren-Guei; Yang, Chung-Shi; Wang, Pen-Cheng; Tseng, Fan-Gang

    2009-06-01

    We present a micro-CEC chip carrying out a highly efficient separation of dsDNA fragments through vertically aligned multi-wall carbon nanotubes (MWCNTs) in a microchannel. The vertically aligned MWCNTs were grown directly in the microchannel to form straight nanopillar arrays as ordered and directional chromatographic supports. 1-Pyrenedodecanoic acid was employed for the surface modification of the MWCNTs' stationary phase to adsorb analytes by hydrophobic interactions. This device was used for separating dsDNA fragments of three different lengths (254, 360, and 572 bp), and fluorescence detection was employed to verify the electrokinetic transport in the MWCNT array. The micro-CEC separation of the three compounds was achieved in less than 300 s at a field strength of 66 V/cm due to superior laminar flow patterns and a lower flow resistance resulting from the vertically aligned MWCNTs being used as the stationary phase medium. In addition, a fivefold reduction of band broadening was obtained when the analyte was separated by the chromatographic MWCNT array channel instead of the CE channel. From all of the results, we suggest that an in situ grown and directional MWCNT array can potentially be useful for preparing more diversified forms of stationary phases for vertically efficient chip-based electrochromatography.

  9. Using Environmental DNA to Improve Species Distribution Models for Freshwater Invaders

    Directory of Open Access Journals (Sweden)

    Teja P. Muha

    2017-12-01

    Full Text Available Species Distribution Models (SDMs have been reported as a useful tool for the risk assessment and modeling of the pathways of dispersal of freshwater invasive alien species (IAS. Environmental DNA (eDNA is a novel tool that can help detect IAS at their early stage of introduction and additionally improve the data available for a more efficient management. SDMs rely on presence and absence of the species in the study area to infer the predictors affecting species distributions. Presence is verified once a species is detected, but confirmation of absence can be problematic because this depends both on the detectability of the species and the sampling strategy. eDNA is a technique that presents higher detectability and accuracy in comparison to conventional sampling techniques, and can effectively differentiate between presence or absence of specific species or entire communities by using a barcoding or metabarcoding approach. However, a number of potential bias can be introduced during (i sampling, (ii amplification, (iii sequencing, or (iv through the usage of bioinformatics pipelines. Therefore, it is important to report and conduct the field and laboratory procedures in a consistent way, by (i introducing eDNA independent observations, (ii amplifying and sequencing control samples, (iii achieving quality sequence reads by appropriate clean-up steps, (iv controlling primer amplification preferences, (v introducing PCR-free sequence capturing, (vi estimating primer detection capabilities through controlled experiments and/or (vii post-hoc introduction of “site occupancy-detection models.” With eDNA methodology becoming increasingly routine, its use is strongly recommended to retrieve species distributional data for SDMs.

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

    Science.gov (United States)

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

    1993-01-01

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

  11. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G. Gomez

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

  12. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez

    2011-01-01

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

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

    Science.gov (United States)

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

    2017-04-15

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

  14. THE IMPACT OF PILATES EXERCISES ON THE POSTURAL ALIGNMENT OF HEALTHY ADULTS

    Directory of Open Access Journals (Sweden)

    Bruna Krawczky

    Full Text Available ABSTRACT Introduction: Exercises of Pilates method have been widely used to improve postural alignment. There is strong evidence favoring their use in improving flexibility and balance, as well as some evidence of improvement in muscle strength. However, the benefits related to posture are not well established. Objective: To investigate in healthy adults, the impact of the Pilates method in the postural alignment through some angles in the sagittal plane and the occurrence of pain before and after an exercise session, and after the completion of a 16-session program. Methods: This is a quasi-experimental study of pre and post-intervention type. Healthy adults (n = 37 interested in starting Pilates were evaluated for acute effects on posture after a Pilates session (n = 37 and after a 16-session program, for a period of 10 weeks (n = 13. Using the postural assessment software (SAPO, six angles were analyzed: head horizontal alignment (HHA, pelvis horizontal alignment (PHA, hip angle (HA, vertical alignment of the body (VAB, thoracic kyphosis (TK, and lumbar lordosis (LL. The occurrence of pain was investigated to control adverse effects. Results: Statistically significant (p<0.05 differences found after one session include increased HHA (left view, decreased VAB (left view and TK (both side views. After 16 sessions, we observed an increase of HHA, and a decrease of TK, LL (both side views and HA (right view. All the differences point to an improvement of postural alignment. A significant reduction of prevalence of pain was verified after the first session (40.5% vs. 13.5%; p=0.004 and after the full program (30.8% vs. 15.3%; p=0.02. Conclusions: Our results suggest that the Pilates method has a positive impact on postural alignment in healthy adults, besides being a safe exercise.

  15. DNA looping by FokI: the impact of twisting and bending rigidity on protein-induced looping dynamics

    Science.gov (United States)

    Laurens, Niels; Rusling, David A.; Pernstich, Christian; Brouwer, Ineke; Halford, Stephen E.; Wuite, Gijs J. L.

    2012-01-01

    Protein-induced DNA looping is crucial for many genetic processes such as transcription, gene regulation and DNA replication. Here, we use tethered-particle motion to examine the impact of DNA bending and twisting rigidity on loop capture and release, using the restriction endonuclease FokI as a test system. To cleave DNA efficiently, FokI bridges two copies of an asymmetric sequence, invariably aligning the sites in parallel. On account of the fixed alignment, the topology of the DNA loop is set by the orientation of the sites along the DNA. We show that both the separation of the FokI sites and their orientation, altering, respectively, the twisting and the bending of the DNA needed to juxtapose the sites, have profound effects on the dynamics of the looping interaction. Surprisingly, the presence of a nick within the loop does not affect the observed rigidity of the DNA. In contrast, the introduction of a 4-nt gap fully relaxes all of the torque present in the system but does not necessarily enhance loop stability. FokI therefore employs torque to stabilise its DNA-looping interaction by acting as a ‘torsional’ catch bond. PMID:22373924

  16. Spontaneous magnetic alignment behaviour in free-living lizards

    Science.gov (United States)

    Diego-Rasilla, Francisco J.; Pérez-Mellado, Valentín; Pérez-Cembranos, Ana

    2017-04-01

    Several species of vertebrates exhibit spontaneous longitudinal body axis alignment relative to the Earth's magnetic field (i.e., magnetic alignment) while they are performing different behavioural tasks. Since magnetoreception is still not fully understood, studying magnetic alignment provides evidence for magnetoreception and broadens current knowledge of magnetic sense in animals. Furthermore, magnetic alignment widens the roles of magnetic sensitivity in animals and may contribute to shed new light on magnetoreception. In this context, spontaneous alignment in two species of lacertid lizards ( Podarcis muralis and Podarcis lilfordi) during basking periods was monitored. Alignments in 255 P. muralis and 456 P. lilfordi were measured over a 5-year period. The possible influence of the sun's position (i.e., altitude and azimuth) and geomagnetic field values corresponding to the moment in which a particular lizard was observed on lizards' body axis orientation was evaluated. Both species exhibited a highly significant bimodal orientation along the north-northeast and south-southwest magnetic axis. The evidence from this study suggests that free-living lacertid lizards exhibit magnetic alignment behaviour, since their body alignments cannot be explained by an effect of the sun's position. On the contrary, lizard orientations were significantly correlated with geomagnetic field values at the time of each observation. We suggest that this behaviour might provide lizards with a constant directional reference while they are sun basking. This directional reference might improve their mental map of space to accomplish efficient escape behaviour. This study is the first to provide spontaneous magnetic alignment behaviour in free-living reptiles.

  17. Improved Method for Direct Detection of Environmental Microorganisms Using an Amplification of 16S rDNA Region

    Science.gov (United States)

    Tsujimura, M.; Akutsu, J.; Zhang, Z.; Sasaki, M.; Tajima, H.; Kawarabayasi, Y.

    2004-12-01

    The thermostable proteins or enzymes were expected to be capable to be utilized in many areas of industries. Many thermophilic microorganisms, which possess the thermostable proteins or enzymes, were identified from the extreme environment. However, many unidentified and uncultivable microorganisms are still remaining in the environment on the earth. It is generally said that the cultivable microorganisms are less than 1% of entire microorganisms living in the earth, remaining over 99% are still uncultivable. As an approach to the uncultivable microorganisms, the PCR amplification of 16S rDNA region using primer sets designed from the conserved region has been generally utilized for detection and community analysis of microorganism in the environment. However, the facts, that PCR amplification introduces the mutation in the amplified DNA fragment and efficiency of PCR amplification is depend on the sequences of primer sets, indicated that the improving of PCR analysis was necessary for more correct detection of microorganisms. As the result of evaluation for the quality of DNA polymerases, sequences of primers used for amplification and conditions of PCR amplification, the DNA polymerase, the primer set and the conditions for amplification, which did not amplify the DNA fragment from the DNA contaminated within the DNA polymerase itself, were successfully selected. Also the rate of mutation in the DNA fragment amplified was evaluated using this conditions and the genomic DNA from cultivable microbes as a template. The result indicated the rate of mutation introduced by PCR was approximately 0.1% to 0.125%. The improved method using these conditions and error rate calculated was applied for the analysis of microorganisms in the geothermal environment. The result indicated that four kinds of dominant microorganisms, including both of bacteria and archaea, were alive within soil in the hot spring in Tohoku Area. We would like to apply this improved method to detection

  18. Going Vertical To Improve the Accuracy of Atomic Force Microscopy Based Single-Molecule Force Spectroscopy.

    Science.gov (United States)

    Walder, Robert; Van Patten, William J; Adhikari, Ayush; Perkins, Thomas T

    2018-01-23

    Single-molecule force spectroscopy (SMFS) is a powerful technique to characterize the energy landscape of individual proteins, the mechanical properties of nucleic acids, and the strength of receptor-ligand interactions. Atomic force microscopy (AFM)-based SMFS benefits from ongoing progress in improving the precision and stability of cantilevers and the AFM itself. Underappreciated is that the accuracy of such AFM studies remains hindered by inadvertently stretching molecules at an angle while measuring only the vertical component of the force and extension, degrading both measurements. This inaccuracy is particularly problematic in AFM studies using double-stranded DNA and RNA due to their large persistence length (p ≈ 50 nm), often limiting such studies to other SMFS platforms (e.g., custom-built optical and magnetic tweezers). Here, we developed an automated algorithm that aligns the AFM tip above the DNA's attachment point to a coverslip. Importantly, this algorithm was performed at low force (10-20 pN) and relatively fast (15-25 s), preserving the connection between the tip and the target molecule. Our data revealed large uncorrected lateral offsets for 100 and 650 nm DNA molecules [24 ± 18 nm (mean ± standard deviation) and 180 ± 110 nm, respectively]. Correcting this offset yielded a 3-fold improvement in accuracy and precision when characterizing DNA's overstretching transition. We also demonstrated high throughput by acquiring 88 geometrically corrected force-extension curves of a single individual 100 nm DNA molecule in ∼40 min and versatility by aligning polyprotein- and PEG-based protein-ligand assays. Importantly, our software-based algorithm was implemented on a commercial AFM, so it can be broadly adopted. More generally, this work illustrates how to enhance AFM-based SMFS by developing more sophisticated data-acquisition protocols.

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

    Science.gov (United States)

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

    2014-07-01

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

  20. Improving head and body pose estimation through semi-supervised manifold alignment

    KAUST Repository

    Heili, Alexandre; Varadarajan, Jagannadan; Ghanem, Bernard; Ahuja, Narendra; Odobez, Jean-Marc

    2014-01-01

    structure of the features in the train and target data and the need to align them were not explored despite the fact that the pose features between two datasets may vary according to the scene, e.g. due to different camera point of view or perspective

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

    Science.gov (United States)

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

    2018-05-09

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

  2. The use of DNA markers for rapid improvement of crops in Africa ...

    African Journals Online (AJOL)

    Genetic engineering and biotechnology are providing new tools for genetic improvement of food crops. Molecular DNA markers are some of these tools which can be used in various fields of plant breeding and germplasm management. For example, molecular markers have been used to confirm the identity of hybrids in ...

  3. Cascaded face alignment via intimacy definition feature

    Science.gov (United States)

    Li, Hailiang; Lam, Kin-Man; Chiu, Man-Yau; Wu, Kangheng; Lei, Zhibin

    2017-09-01

    Recent years have witnessed the emerging popularity of regression-based face aligners, which directly learn mappings between facial appearance and shape-increment manifolds. We propose a random-forest based, cascaded regression model for face alignment by using a locally lightweight feature, namely intimacy definition feature. This feature is more discriminative than the pose-indexed feature, more efficient than the histogram of oriented gradients feature and the scale-invariant feature transform feature, and more compact than the local binary feature (LBF). Experimental validation of our algorithm shows that our approach achieves state-of-the-art performance when testing on some challenging datasets. Compared with the LBF-based algorithm, our method achieves about twice the speed, 20% improvement in terms of alignment accuracy and saves an order of magnitude on memory requirement.

  4. Alignment of Custom Standards by Machine Learning Algorithms

    Directory of Open Access Journals (Sweden)

    Adela Sirbu

    2010-09-01

    Full Text Available Building an efficient model for automatic alignment of terminologies would bring a significant improvement to the information retrieval process. We have developed and compared two machine learning based algorithms whose aim is to align 2 custom standards built on a 3 level taxonomy, using kNN and SVM classifiers that work on a vector representation consisting of several similarity measures. The weights utilized by the kNN were optimized with an evolutionary algorithm, while the SVM classifier's hyper-parameters were optimized with a grid search algorithm. The database used for train was semi automatically obtained by using the Coma++ tool. The performance of our aligners is shown by the results obtained on the test set.

  5. A novel method of selective removal of human DNA improves PCR sensitivity for detection of Salmonella Typhi in blood samples.

    Science.gov (United States)

    Zhou, Liqing; Pollard, Andrew J

    2012-07-27

    Enteric fever is a major public health problem, causing an estimated 21million new cases and 216,000 or more deaths every year. Current diagnosis of the disease is inadequate. Blood culture only identifies 45 to 70% of the cases and is time-consuming. Serological tests have very low sensitivity and specificity. Clinical samples obtained for diagnosis of enteric fever in the field generally have blood, so that even PCR-based methods, widely used for detection of other infectious diseases, are not a straightforward option in typhoid diagnosis. We developed a novel method to enrich target bacterial DNA by selective removal of human DNA from blood samples, enhancing the sensitivity of PCR tests. This method offers the possibility of improving PCR assays directly using clinical specimens for diagnosis of this globally important infectious disease. Blood samples were mixed with ox bile for selective lysis of human blood cells and the released human DNA was then digested with addition of bile resistant micrococcal nuclease. The intact Salmonella Typhi bacteria were collected from the specimen by centrifugation and the DNA extracted with QIAamp DNA mini kit. The presence of Salmonella Typhi bacteria in blood samples was detected by PCR with the fliC-d gene of Salmonella Typhi as the target. Micrococcal nuclease retained activity against human blood DNA in the presence of up to 9% ox bile. Background human DNA was dramatically removed from blood samples through the use of ox bile lysis and micrococcal nuclease for removal of mammalian DNA. Consequently target Salmonella Typhi DNA was enriched in DNA preparations and the PCR sensitivity for detection of Salmonella Typhi in spiked blood samples was enhanced by 1,000 fold. Use of a combination of selective ox-bile blood cell lysis and removal of human DNA with micrococcal nuclease significantly improves PCR sensitivity and offers a better option for improved typhoid PCR assays directly using clinical specimens in diagnosis of

  6. Stability and alignment do not improve by using patient-specific instrumentation in total knee arthroplasty: a randomized controlled trial.

    Science.gov (United States)

    Kosse, Nienke M; Heesterbeek, Petra J C; Schimmel, Janneke J P; van Hellemondt, Gijs G; Wymenga, Ate B; Defoort, Koen C

    2018-06-01

    The primary aim of the study was to examine stability and alignment after total knee arthroplasty (TKA) using patient-specific instrumentation (PSI) and conventional instrumentation (CI). The hypothesis was that stability and alignment would be better using PSI than CI, 12 months postoperatively. The secondary aim included the evaluation of clinical outcomes after TKA. In this prospective randomized controlled trial, 42 patients with knee osteoarthritis received a Genesis II PS prosthesis with either PSI or CI. Patients visited the hospital preoperatively and postoperatively after 6 weeks and 3 and 12 months. To evaluate stability, varus-valgus laxity was determined in extension and flexion using stress radiographs 12 months postoperatively. Three months postoperatively, a long-leg radiograph and CT scan were obtained to measure hip-knee-ankle (HKA) alignment and component rotation. Furthermore, frontal and sagittal alignment of the components, the Knee Society Score, VAS Pain, VAS Satisfaction, Knee injury and Osteoarthritis Outcome score, Patella score (Kujala), University of California Los Angeles activity score, anterior-posterior laxity, (serious) adverse device-related events, and intraoperative complications were reported. The clinical outcomes were compared using independent t tests or non-parametric alternatives, and repeated measurements ANOVA with a significance level of p stability, HKA angle, and rotational alignment. In four patients, the PSI did not fit correctly on the tibia and/or femur requiring intraoperative modifications. Both groups improved significantly over time on all clinical outcomes, with no significant differences between the groups 12 months postoperatively. The PSI group showed less tibial slope than the patients in the CI group [PSI 2.6° versus CI 4.8° (p = 0.02)]. Finally, the PSI group more frequently received a thinner insert size than the CI group (p = 0.03). Patients operated with PSI did not differ from CI in

  7. Modeling electrical conductivities of nanocomposites with aligned carbon nanotubes

    International Nuclear Information System (INIS)

    Bao, W S; Meguid, S A; Zhu, Z H; Meguid, M J

    2011-01-01

    We have developed an improved three-dimensional (3D) percolation model to investigate the effect of the alignment of carbon nanotubes (CNTs) on the electrical conductivity of nanocomposites. In this model, both intrinsic and contact resistances are considered, and a new method of resistor network recognition that employs periodically connective paths is developed. This method leads to a reduction in the size effect of the representative cuboid in our Monte Carlo simulations. With this new technique, we were able to effectively analyze the effects of the CNT alignment upon the electrical conductivity of nanocomposites. Our model predicted that the peak value of the conductivity occurs for partially aligned rather than perfectly aligned CNTs. It has also identified the value of the peak and the corresponding alignment for different volume fractions of CNTs. Our model works well for both multi-wall CNTs (MWCNTs) and single-wall CNTs (SWCNTs), and the numerical results show a quantitative agreement with existing experimental observations.

  8. Fabrication Process Changes for Performance Improvement of a RF MEMS Resonator: Conformable Contact Lithography, Moire Alignment, and Chlorine Dry Etching

    National Research Council Canada - National Science Library

    Sakai, Mark

    2005-01-01

    .... A CCL process utilizing moire alignment marks is described. An automated moire-based alignment system using Labview software is presented which demonstrates sub-100 nm alignment accuracy for a single alignment mark...

  9. Charge Transport in 2D DNA Tunnel Junction Diodes

    KAUST Repository

    Yoon, Minho

    2017-11-06

    Recently, deoxyribonucleic acid (DNA) is studied for electronics due to its intrinsic benefits such as its natural plenitude, biodegradability, biofunctionality, and low-cost. However, its applications are limited to passive components because of inherent insulating properties. In this report, a metal-insulator-metal tunnel diode with Au/DNA/NiOx junctions is presented. Through the self-aligning process of DNA molecules, a 2D DNA nanosheet is synthesized and used as a tunneling barrier, and semitransparent conducting oxide (NiOx ) is applied as a top electrode for resolving metal penetration issues. This molecular device successfully operates as a nonresonant tunneling diode, and temperature-variable current-voltage analysis proves that Fowler-Nordheim tunneling is a dominant conduction mechanism at the junctions. DNA-based tunneling devices appear to be promising prototypes for nanoelectronics using biomolecules.

  10. Charge Transport in 2D DNA Tunnel Junction Diodes

    KAUST Repository

    Yoon, Minho; Min, Sung-Wook; Dugasani, Sreekantha Reddy; Lee, Yong Uk; Oh, Min Suk; Anthopoulos, Thomas D.; Park, Sung Ha; Im, Seongil

    2017-01-01

    Recently, deoxyribonucleic acid (DNA) is studied for electronics due to its intrinsic benefits such as its natural plenitude, biodegradability, biofunctionality, and low-cost. However, its applications are limited to passive components because of inherent insulating properties. In this report, a metal-insulator-metal tunnel diode with Au/DNA/NiOx junctions is presented. Through the self-aligning process of DNA molecules, a 2D DNA nanosheet is synthesized and used as a tunneling barrier, and semitransparent conducting oxide (NiOx ) is applied as a top electrode for resolving metal penetration issues. This molecular device successfully operates as a nonresonant tunneling diode, and temperature-variable current-voltage analysis proves that Fowler-Nordheim tunneling is a dominant conduction mechanism at the junctions. DNA-based tunneling devices appear to be promising prototypes for nanoelectronics using biomolecules.

  11. Iterative local Chi2 alignment approach for the ATLAS SCT detector

    CERN Document Server

    Härtel, Roland

    An approach for the alignment of SCT modules in the ATLAS Inner Detector with particle tracks was developed and implemented in the ATLAS software framework Athena. The approach uses distance of closest approach residuals and a linear least squares minimization to derive the most probable set of alignment parameters for each module. The procedure is iterative, i.e. with the first set of alignment constants a track refit is done and the alignment algorithm is repeated. Correlations between modules are only implicitly taken into account due to the improvement of track parameters through the iterations. A derivation of the underlying concepts is presented. The achievable accuracy and limits of the alignment approach were studied with Monte Carlo simulated tracks in the Athena framework. The results and limitations obtained with the present versions of Athena and the proposed alignment software are presented.

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

  13. Position list word aligned hybrid

    DEFF Research Database (Denmark)

    Deliege, Francois; Pedersen, Torben Bach

    2010-01-01

    Compressed bitmap indexes are increasingly used for efficiently querying very large and complex databases. The Word Aligned Hybrid (WAH) bitmap compression scheme is commonly recognized as the most efficient compression scheme in terms of CPU efficiency. However, WAH compressed bitmaps use a lot...... of storage space. This paper presents the Position List Word Aligned Hybrid (PLWAH) compression scheme that improves significantly over WAH compression by better utilizing the available bits and new CPU instructions. For typical bit distributions, PLWAH compressed bitmaps are often half the size of WAH...... bitmaps and, at the same time, offer an even better CPU efficiency. The results are verified by theoretical estimates and extensive experiments on large amounts of both synthetic and real-world data....

  14. LHCb full-detector real-time alignment and calibration: latest developments and perspective

    CERN Multimedia

    Dziurda, Agnieszka

    2018-01-01

    A key ingredient of the data taking strategy used by the LHCb experiment at CERN in Run 2 is the novel real-time detector alignment and calibration. Data collected at the start of the fill are processed within minutes and used to update the alignment, while the calibration constants are evaluated hourly. This is one of the key elements which allow the reconstruction quality of the software trigger in Run-II to be as good as the offline quality of Run 1. The most recent developments of the real-time alignment and calibration paradigm enable the fully automated updates of the RICH detectors' mirror alignment and a novel calibration of the calorimeter systems. Both evolutions improve the particle identification performance stability resulting in higher purity selections. The latter leads also to an improvement in the energy measurement of neutral particles, resulting in a 15% better mass resolution of radiative b-hadron decays. A large variety of improvements has been explored for the last year of Run 2 data tak...

  15. Directional plasticity rapidly improves 3D vestibulo-ocular reflex alignment in monkeys using a multichannel vestibular prosthesis.

    Science.gov (United States)

    Dai, Chenkai; Fridman, Gene Y; Chiang, Bryce; Rahman, Mehdi A; Ahn, Joong Ho; Davidovics, Natan S; Della Santina, Charles C

    2013-12-01

    Bilateral loss of vestibular sensation can be disabling. We have shown that a multichannel vestibular prosthesis (MVP) can partly restore vestibular sensation as evidenced by improvements in the 3-dimensional angular vestibulo-ocular reflex (3D VOR). However, a key challenge is to minimize misalignment between the axes of eye and head rotation, which is apparently caused by current spread beyond each electrode's targeted nerve branch. We recently reported that rodents wearing a MVP markedly improve 3D VOR alignment during the first week after MVP activation, probably through the same central nervous system adaptive mechanisms that mediate cross-axis adaptation over time in normal individuals wearing prisms that cause visual scene movement about an axis different than the axis of head rotation. We hypothesized that rhesus monkeys would exhibit similar improvements with continuous prosthetic stimulation over time. We created bilateral vestibular deficiency in four rhesus monkeys via intratympanic injection of gentamicin. A MVP was mounted to the cranium, and eye movements in response to whole-body passive rotation in darkness were measured repeatedly over 1 week of continuous head motion-modulated prosthetic electrical stimulation. 3D VOR responses to whole-body rotations about each semicircular canal axis were measured on days 1, 3, and 7 of chronic stimulation. Horizontal VOR gain during 1 Hz, 50 °/s peak whole-body rotations before the prosthesis was turned on was prosthetic stimulation under normal diurnal lighting. Similar improvements were noted for all animals, all three axes of rotation tested, for all sinusoidal frequencies tested (0.05-5 Hz), and for high-acceleration transient rotations. VOR asymmetry changes did not reach statistical significance, although they did trend toward slight improvement over time. Prior studies had already shown that directional plasticity reduces misalignment when a subject with normal labyrinths views abnormal visual scene

  16. Functionalization of vertically aligned carbon nanotubes

    Directory of Open Access Journals (Sweden)

    Eloise Van Hooijdonk

    2013-02-01

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

  17. Functionalization of vertically aligned carbon nanotubes.

    Science.gov (United States)

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

    2013-01-01

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

  18. Improving Probe Immobilization for Label-Free Capacitive Detection of DNA Hybridization on Microfabricated Gold Electrodes

    Directory of Open Access Journals (Sweden)

    Sandro Carrara

    2008-02-01

    Full Text Available Alternative approaches to labeled optical detection for DNA arrays are actively investigated for low-cost point-of-care applications. In this domain, label-free capacitive detection is one of the most intensely studied techniques. It is based on the idea to detect the Helmholtz ion layer displacements when molecular recognition occurs at the electrodes/solution interface. The sensing layer is usually prepared by using thiols terminated DNA single-strength oligonucleotide probes on top of the sensor electrodes. However, published data shows evident time drift, which greatly complicates signal conditioning and processing and ultimately increases the uncertainty in DNA recognition sensing. The aim of this work is to show that newly developed ethylene-glycol functionalized alkanethiols greatly reduce time drift, thereby significantly improving capacitance based label-free detection of DNA.

  19. Synthesis and orientation of barium hexaferrite ceramics by magnetic alignment

    Science.gov (United States)

    Autissier, Denis

    1990-01-01

    Particles of Ba 2Mn xZn 2- xFe 12O 22 with planar structure were prepared by chemical precipitation. They were processed by sleep casting in presence of a magnetic field. The degree of alignment was improved by a special sintering treatment. By this procedure an alignment as high as 99.9% is obtained.

  20. Enabling Process Alignment for IT Entrepreneurship

    Directory of Open Access Journals (Sweden)

    Sonia D. Bot

    2012-11-01

    Full Text Available All firms use information technology (IT. Larger firms have IT organizations whose business function is to supply and manage IT infrastructure and applications to support the firm's business objectives. Regardless of whether the IT function has been outsourced or is resident within a firm, the objectives of the IT organization must be aligned to the strategic needs of the business. It is often a challenge to balance the demand for IT against the available supply within the firm. Most IT organizations have little capacity to carry out activities that go beyond the incremental ones that are needed to run the immediate needs of the business. A process-ambidexterity framework for IT improves the IT organization's entrepreneurial ability, which in turn, better aligns the IT function with the business functions in the firm. Process ambidexterity utilizes both process alignment and process adaptability. This article presents a framework for process alignment in IT. This is useful for understanding how the processes in Business Demand Management, a core component of the process-ambidexterity framework for IT, relate to those in IT Governance and IT Supply Chain Management. The framework is presented through three lenses (governance, business, and technology along with real-world examples from major firms in the USA. Enabling process alignment in the IT function, and process ambidexterity overall, benefits those who govern IT, the executives who lead IT, as well as their peers in the business functions that depend on IT.

  1. PriFi - Using a Multiple Alignment of Related Sequences to Find Primers for  Amplification of Homologs

    DEFF Research Database (Denmark)

    Fredslund, Jakob; Schauser, Leif; Madsen, Lene Heegaard

    2005-01-01

    Using a comparative approach, the web program PriFi (http://cgi-www.daimi.au.dk/cgi-chili/PriFi/main) designs pairs of primers useful for PCR amplification of genomic DNA in species where prior sequence information is not available. The program works with an alignment of DNA sequences from...... of a procedure for developing general markers serving as common anchor loci across species. To accommodate users with special preferences, configuration settings and criteria can be customized....

  2. ATLAS Inner Detector Alignment Performance with February 2015 Cosmic Rays Data

    CERN Document Server

    The ATLAS collaboration

    2015-01-01

    Results of the first alignment of the new insertable B-Layer, which was installed during the first long shutdown, are presented. These results were obtained by using cosmic ray data collected in February 2015. Different alignment techniques have been used to improve the description of the detector geometry. After the alignment, biases in the track-to-hit residuals in cosmic ray data events have been corrected, and the improvement of the active modules resolution is quantified in terms of the Full Width Half Maximum figures of merit. The IBL global position has been determined at micron level with an averaged module resolution of 32 $\\mu$m along the most sensitive direction of the module. Track parameters resolution has been studied using reconstructed split tracks.

  3. An Improved Methodology to Overcome Key Issues in Human Fecal Metagenomic DNA Extraction

    DEFF Research Database (Denmark)

    Kumar, Jitendra; Kumar, Manoj; Gupta, Shashank

    2016-01-01

    Microbes are ubiquitously distributed in nature, and recent culture-independent studies have highlighted the significance of gut microbiota in human health and disease. Fecal DNA is the primary source for the majority of human gut microbiome studies. However, further improvement is needed to obta...

  4. CMS Tracker Alignment Performance Results Start-Up 2017

    CERN Document Server

    CMS Collaboration

    2017-01-01

    During the LHC shutdown in Winter 2016/17, the CMS pixel detector, the inner component of the CMS Tracker, was replaced by the Phase-1 upgrade detector. Among others improvements, the new pixel detector consists of four instead of three layers in the central barrel region (BPIX) and three instead of two disks in the endcap regions (FPIX). In this report, performance plots of the first pixel-detector alignment results are presented, which were obtained with cosmic-ray data taken prior to the start of the 2017 LHC pp operation. Alignment constants have been derived using the data collected initially at 0T and later at 3.8T magnetic field to the level of single module positions in the pixel detector, while keeping the alignment parameters of the strip detector fixed at the values determined in the end of 2016. The complete understanding of the alignment and biases was derived by using two algorithms, Millepede-II and HipPy. The results confirm each other.

  5. Simulator for beam-based LHC collimator alignment

    Science.gov (United States)

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

    2014-02-01

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

  6. Photoconductivity in DNA-Porphyrin Complexes

    Science.gov (United States)

    Myint, Peco; Oxford, Emma; Nyazenga, Collence; Smith, Walter; Qi, Zhengqing; Johnson, A. T.

    2015-03-01

    We have measured the photoconductivity of λ - DNA that is modified by intercalating a porphyrin compound, meso-tetrakis(N-methyl-4-pyridiniumyl)porphyrin (TMPyP), into its base stacks. Intercalation was verified by a red shift and hypochromism of the Soret absorption peak. The DNA/porphyrin strands were then deposited onto oxidized silicon substrates which had been patterned with interdigitated electrodes, and blown dry. Electrical measurements were carried out under nitrogen, using illumination from a 445 nm laser; this wavelength falls within the absorption peak of the DNA/porphyrin complexes. When initially measured under dry nitrogen, the complexes show no photoconductivity or dark conductivity. However, at relative humidities of 30% and above, we do observe dark conductivity, and also photoconductivity that grows with time. Photoconductivity gets larger at higher relative humidity. Remarkably, when the humidity is lowered again, some photoconductivity is now observed, indicating a change that persists for more than 24 hours. It may be that the humidity alters the structure of the DNA, perhaps allowing for better alignment of the bases. This work was supported by NSF Grant BMAT-1306170.

  7. Interactive software tool to comprehend the calculation of optimal sequence alignments with dynamic programming.

    Science.gov (United States)

    Ibarra, Ignacio L; Melo, Francisco

    2010-07-01

    Dynamic programming (DP) is a general optimization strategy that is successfully used across various disciplines of science. In bioinformatics, it is widely applied in calculating the optimal alignment between pairs of protein or DNA sequences. These alignments form the basis of new, verifiable biological hypothesis. Despite its importance, there are no interactive tools available for training and education on understanding the DP algorithm. Here, we introduce an interactive computer application with a graphical interface, for the purpose of educating students about DP. The program displays the DP scoring matrix and the resulting optimal alignment(s), while allowing the user to modify key parameters such as the values in the similarity matrix, the sequence alignment algorithm version and the gap opening/extension penalties. We hope that this software will be useful to teachers and students of bioinformatics courses, as well as researchers who implement the DP algorithm for diverse applications. The software is freely available at: http:/melolab.org/sat. The software is written in the Java computer language, thus it runs on all major platforms and operating systems including Windows, Mac OS X and LINUX. All inquiries or comments about this software should be directed to Francisco Melo at fmelo@bio.puc.cl.

  8. Study on Dynamic Alignment Technology of COIL Resonator

    International Nuclear Information System (INIS)

    Xiong, M D; Zou, X J; Guo, J H; Jia, S N; Zhang, Z B

    2006-01-01

    The performance of great power chemical oxygen-iodine laser (COIL) beam is decided mostly by resonator mirror maladjustment and environment vibration. To improve the performance of light beam, an auto-alignment device is used in COIL resonator, the device can keep COIL resonator collimating by adjusting the optical components of resonator. So the coupling model of COIL resonator is present. The multivariable self study fuzzy uncoupling arithmetic and six-dimensional micro drive technology are used to design a six-input-three-output uncoupling controller, resulting in the realization of the high precision dynamic alignment. The experiments indicate that the collimating range of this system is 8 mrad, precision is 5 urad and frequency response is 20Hz, which meet the demand of resonator alignment system

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

    Science.gov (United States)

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

    2015-09-03

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

  10. SVM-dependent pairwise HMM: an application to protein pairwise alignments.

    Science.gov (United States)

    Orlando, Gabriele; Raimondi, Daniele; Khan, Taushif; Lenaerts, Tom; Vranken, Wim F

    2017-12-15

    Methods able to provide reliable protein alignments are crucial for many bioinformatics applications. In the last years many different algorithms have been developed and various kinds of information, from sequence conservation to secondary structure, have been used to improve the alignment performances. This is especially relevant for proteins with highly divergent sequences. However, recent works suggest that different features may have different importance in diverse protein classes and it would be an advantage to have more customizable approaches, capable to deal with different alignment definitions. Here we present Rigapollo, a highly flexible pairwise alignment method based on a pairwise HMM-SVM that can use any type of information to build alignments. Rigapollo lets the user decide the optimal features to align their protein class of interest. It outperforms current state of the art methods on two well-known benchmark datasets when aligning highly divergent sequences. A Python implementation of the algorithm is available at http://ibsquare.be/rigapollo. wim.vranken@vub.be. 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. Absence of ancient DNA in sub-fossil insect inclusions preserved in 'Anthropocene' Colombian copal.

    Directory of Open Access Journals (Sweden)

    David Penney

    Full Text Available Insects preserved in copal, the sub-fossilized resin precursor of amber, have potential value in molecular ecological studies of recently-extinct species and of extant species that have never been collected as living specimens. The objective of the work reported in this paper was therefore to determine if ancient DNA is present in insects preserved in copal. We prepared DNA libraries from two stingless bees (Apidae: Meliponini: Trigonisca ameliae preserved in 'Anthropocene' Colombian copal, dated to 'post-Bomb' and 10,612±62 cal yr BP, respectively, and obtained sequence reads using the GS Junior 454 System. Read numbers were low, but were significantly higher for DNA extracts prepared from crushed insects compared with extracts obtained by a non-destructive method. The younger specimen yielded sequence reads up to 535 nucleotides in length, but searches of these sequences against the nucleotide database revealed very few significant matches. None of these hits was to stingless bees though one read of 97 nucleotides aligned with two non-contiguous segments of the mitochondrial cytochrome oxidase subunit I gene of the East Asia bumblebee Bombus hypocrita. The most significant hit was for 452 nucleotides of a 470-nucleotide read that aligned with part of the genome of the root-nodulating bacterium Bradyrhizobium japonicum. The other significant hits were to proteobacteria and an actinomycete. Searches directed specifically at Apidae nucleotide sequences only gave short and insignificant alignments. All of the reads from the older specimen appeared to be artefacts. We were therefore unable to obtain any convincing evidence for the preservation of ancient DNA in either of the two copal inclusions that we studied, and conclude that DNA is not preserved in this type of material. Our results raise further doubts about claims of DNA extraction from fossil insects in amber, many millions of years older than copal.

  12. MaxAlign: maximizing usable data in an alignment

    DEFF Research Database (Denmark)

    Oliveira, Rodrigo Gouveia; Sackett, Peter Wad; Pedersen, Anders Gorm

    2007-01-01

    Align. In this paper we also introduce a new simple measure of tree similarity, Normalized Symmetric Similarity (NSS) that we consider useful for comparing tree topologies. CONCLUSION: We demonstrate how MaxAlign is helpful in detecting misaligned or defective sequences without requiring manual inspection. We also...

  13. Aligning for Innovation - Alignment Strategy to Drive Innovation

    Science.gov (United States)

    Johnson, Hurel; Teltschik, David; Bussey, Horace, Jr.; Moy, James

    2010-01-01

    With the sudden need for innovation that will help the country achieve its long-term space exploration objectives, the question of whether NASA is aligned effectively to drive the innovation that it so desperately needs to take space exploration to the next level should be entertained. Authors such as Robert Kaplan and David North have noted that companies that use a formal system for implementing strategy consistently outperform their peers. They have outlined a six-stage management systems model for implementing strategy, which includes the aligning of the organization towards its objectives. This involves the alignment of the organization from the top down. This presentation will explore the impacts of existing U.S. industrial policy on technological innovation; assess the current NASA organizational alignment and its impacts on driving technological innovation; and finally suggest an alternative approach that may drive the innovation needed to take the world to the next level of space exploration, with NASA truly leading the way.

  14. Predicting Consensus Structures for RNA Alignments Via Pseudo-Energy Minimization

    Directory of Open Access Journals (Sweden)

    Junilda Spirollari

    2009-01-01

    Full Text Available Thermodynamic processes with free energy parameters are often used in algorithms that solve the free energy minimization problem to predict secondary structures of single RNA sequences. While results from these algorithms are promising, an observation is that single sequence-based methods have moderate accuracy and more information is needed to improve on RNA secondary structure prediction, such as covariance scores obtained from multiple sequence alignments. We present in this paper a new approach to predicting the consensus secondary structure of a set of aligned RNA sequences via pseudo-energy minimization. Our tool, called RSpredict, takes into account sequence covariation and employs effective heuristics for accuracy improvement. RSpredict accepts, as input data, a multiple sequence alignment in FASTA or ClustalW format and outputs the consensus secondary structure of the input sequences in both the Vienna style Dot Bracket format and the Connectivity Table format. Our method was compared with some widely used tools including KNetFold, Pfold and RNAalifold. A comprehensive test on different datasets including Rfam sequence alignments and a multiple sequence alignment obtained from our study on the Drosophila X chromosome reveals that RSpredict is competitive with the existing tools on the tested datasets. RSpredict is freely available online as a web server and also as a jar file for download at http:// datalab.njit.edu/biology/RSpredict.

  15. DNA barcoding the floras of biodiversity hotspots.

    Science.gov (United States)

    Lahaye, Renaud; van der Bank, Michelle; Bogarin, Diego; Warner, Jorge; Pupulin, Franco; Gigot, Guillaume; Maurin, Olivier; Duthoit, Sylvie; Barraclough, Timothy G; Savolainen, Vincent

    2008-02-26

    DNA barcoding is a technique in which species identification is performed by using DNA sequences from a small fragment of the genome, with the aim of contributing to a wide range of ecological and conservation studies in which traditional taxonomic identification is not practical. DNA barcoding is well established in animals, but there is not yet any universally accepted barcode for plants. Here, we undertook intensive field collections in two biodiversity hotspots (Mesoamerica and southern Africa). Using >1,600 samples, we compared eight potential barcodes. Going beyond previous plant studies, we assessed to what extent a "DNA barcoding gap" is present between intra- and interspecific variations, using multiple accessions per species. Given its adequate rate of variation, easy amplification, and alignment, we identified a portion of the plastid matK gene as a universal DNA barcode for flowering plants. Critically, we further demonstrate the applicability of DNA barcoding for biodiversity inventories. In addition, analyzing >1,000 species of Mesoamerican orchids, DNA barcoding with matK alone reveals cryptic species and proves useful in identifying species listed in Convention on International Trade of Endangered Species (CITES) appendixes.

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

    Science.gov (United States)

    Comin, Matteo; Leoni, Andrea; Schimd, Michele

    2015-01-01

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

  17. The use of caspase inhibitors in pulsed-field gel electrophoresis may improve the estimation of radiation-induced DNA repair and apoptosis

    International Nuclear Information System (INIS)

    Balart, Josep; Pueyo, Gemma; Llobet, Lara I de; Baro, Marta; Sole, Xavi; Marin, Susanna; Casanovas, Oriol; Mesia, Ricard; Capella, Gabriel

    2011-01-01

    Radiation-induced DNA double-strand break (DSB) repair can be tested by using pulsed-field gel electrophoresis (PFGE) in agarose-encapsulated cells. However, previous studies have reported that this assay is impaired by the spontaneous DNA breakage in this medium. We investigated the mechanisms of this fragmentation with the principal aim of eliminating it in order to improve the estimation of radiation-induced DNA repair. Samples from cancer cell cultures or xenografted tumours were encapsulated in agarose plugs. The cell plugs were then irradiated, incubated to allow them to repair, and evaluated by PFGE, caspase-3, and histone H2AX activation (γH2AX). In addition, apoptosis inhibition was evaluated through chemical caspase inhibitors. We confirmed that spontaneous DNA fragmentation was associated with the process of encapsulation, regardless of whether cells were irradiated or not. This DNA fragmentation was also correlated to apoptosis activation in a fraction of the cells encapsulated in agarose, while non-apoptotic cell fraction could rejoin DNA fragments as was measured by γH2AX decrease and PFGE data. We were able to eliminate interference of apoptosis by applying specific caspase inhibitors, and improve the estimation of DNA repair, and apoptosis itself. The estimation of radiation-induced DNA repair by PFGE may be improved by the use of apoptosis inhibitors. The ability to simultaneously determine DNA repair and apoptosis, which are involved in cell fate, provides new insights for using the PFGE methodology as functional assay

  18. A microfluidic DNA library preparation platform for next-generation sequencing.

    Science.gov (United States)

    Kim, Hanyoup; Jebrail, Mais J; Sinha, Anupama; Bent, Zachary W; Solberg, Owen D; Williams, Kelly P; Langevin, Stanley A; Renzi, Ronald F; Van De Vreugde, James L; Meagher, Robert J; Schoeniger, Joseph S; Lane, Todd W; Branda, Steven S; Bartsch, Michael S; Patel, Kamlesh D

    2013-01-01

    Next-generation sequencing (NGS) is emerging as a powerful tool for elucidating genetic information for a wide range of applications. Unfortunately, the surging popularity of NGS has not yet been accompanied by an improvement in automated techniques for preparing formatted sequencing libraries. To address this challenge, we have developed a prototype microfluidic system for preparing sequencer-ready DNA libraries for analysis by Illumina sequencing. Our system combines droplet-based digital microfluidic (DMF) sample handling with peripheral modules to create a fully-integrated, sample-in library-out platform. In this report, we use our automated system to prepare NGS libraries from samples of human and bacterial genomic DNA. E. coli libraries prepared on-device from 5 ng of total DNA yielded excellent sequence coverage over the entire bacterial genome, with >99% alignment to the reference genome, even genome coverage, and good quality scores. Furthermore, we produced a de novo assembly on a previously unsequenced multi-drug resistant Klebsiella pneumoniae strain BAA-2146 (KpnNDM). The new method described here is fast, robust, scalable, and automated. Our device for library preparation will assist in the integration of NGS technology into a wide variety of laboratories, including small research laboratories and clinical laboratories.

  19. A microfluidic DNA library preparation platform for next-generation sequencing.

    Directory of Open Access Journals (Sweden)

    Hanyoup Kim

    Full Text Available Next-generation sequencing (NGS is emerging as a powerful tool for elucidating genetic information for a wide range of applications. Unfortunately, the surging popularity of NGS has not yet been accompanied by an improvement in automated techniques for preparing formatted sequencing libraries. To address this challenge, we have developed a prototype microfluidic system for preparing sequencer-ready DNA libraries for analysis by Illumina sequencing. Our system combines droplet-based digital microfluidic (DMF sample handling with peripheral modules to create a fully-integrated, sample-in library-out platform. In this report, we use our automated system to prepare NGS libraries from samples of human and bacterial genomic DNA. E. coli libraries prepared on-device from 5 ng of total DNA yielded excellent sequence coverage over the entire bacterial genome, with >99% alignment to the reference genome, even genome coverage, and good quality scores. Furthermore, we produced a de novo assembly on a previously unsequenced multi-drug resistant Klebsiella pneumoniae strain BAA-2146 (KpnNDM. The new method described here is fast, robust, scalable, and automated. Our device for library preparation will assist in the integration of NGS technology into a wide variety of laboratories, including small research laboratories and clinical laboratories.

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

  1. Improving Griffith's protocol for co-extraction of microbial DNA and RNA in adsorptive soils

    DEFF Research Database (Denmark)

    Paulin, Mélanie Marie; Nicolaisen, Mette Haubjerg; Jacobsen, Carsten Suhr

    2013-01-01

    Quantification of microbial gene expression is increasingly being used to study key functions in soil microbial communities, yet major limitations still exist for efficient extraction of nucleic acids, especially RNA for transcript analysis, from this complex matrix. We present an improved......-time PCR on both the RNA (after conversion to cDNA) and the DNA fraction of the extracts. Non-adsorptive soils were characterized by low clay content and/or high phosphate content, whereas adsorptive soils had clay contents above 20% and/or a strong presence of divalent Ca in combination with high p......H. Modifications to the co-extraction protocol improved nucleic acid extraction efficiency from all adsorptive soils and were successfully validated by DGGE analysis of the indigenous community based on 16S rRNA gene and transcripts in soils representing low biomass and/or high clay content. This new approach...

  2. Acetone facilitated DNA sampling from electrical tapes improves DNA recovery and enables latent fingerprints development.

    Science.gov (United States)

    Feine, Ilan; Shpitzen, Moshe; Geller, Boris; Salmon, Eran; Peleg, Tsach; Roth, Jonathan; Gafny, Ron

    2017-07-01

    Electrical tapes (ETs) are a common component of improvised explosive devices (IEDs) used by terrorists or criminal organizations and represent a valuable forensic resource for DNA and latent fingerprints recovery. However, DNA recovery rates are typically low and usually below the minimal amount required for amplification. In addition, most DNA extraction methods are destructive and do not allow further latent fingerprints development. In the present study a cell culture based touch DNA model was used to demonstrate a two-step acetone-water DNA recovery protocol from ETs. This protocol involves only the adhesive side of the ET and increases DNA recovery rates by up to 70%. In addition, we demonstrated partially successful latent fingerprints development from the non-sticky side of the ETs. Taken together, this protocol maximizes the forensic examination of ETs and is recommended for routine casework processing. Copyright © 2017 Elsevier B.V. All rights reserved.

  3. Novel Real-time Calibration and Alignment Procedure for LHCb Run II

    CERN Multimedia

    Prouve, Claire

    2016-01-01

    In order to achieve optimal detector performance the LHCb experiment has introduced a novel real-time detector alignment and calibration strategy for Run II of the LHC. For the alignment tasks, data is collected and processed at the beginning of each fill while the calibrations are performed for each run. This real time alignment and calibration allows the same constants being used in both the online and offline reconstruction, thus improving the correlation between triggered and offline selected events. Additionally the newly computed alignment and calibration constants can be instantly used in the trigger, making it more efficient. The online alignment and calibration of the RICH detectors also enable the use of hadronic particle identification in the trigger. The computing time constraints are met through the use of a new dedicated framework using the multi-core farm infrastructure for the LHCb trigger. An overview of all alignment and calibration tasks is presented and their performance is shown.

  4. Control rod housing alignment

    International Nuclear Information System (INIS)

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

    1990-01-01

    This patent describes a process for measuring the vertical alignment between a hole in a core plate and the top of a corresponding control rod drive housing within a boiling water reactor. It comprises: providing an alignment apparatus. The alignment apparatus including a lower end for fitting to the top of the control rod drive housing; an upper end for fitting to the aperture in the core plate, and a leveling means attached to the alignment apparatus to read out the difference in angularity with respect to gravity, and alignment pin registering means for registering to the alignment pin on the core plate; lowering the alignment device on a depending support through a lattice position in the top guide through the hole in the core plate down into registered contact with the top of the control rod drive housing; registering the upper end to the sides of the hole in the core plate; registering the alignment pin registering means to an alignment pin on the core plate to impart to the alignment device the required angularity; and reading out the angle of the control rod drive housing with respect to the hole in the core plate through the leveling devices whereby the angularity of the top of the control rod drive housing with respect to the hole in the core plate can be determined

  5. Inspecting Targeted Deep Sequencing of Whole Genome Amplified DNA Versus Fresh DNA for Somatic Mutation Detection: A Genetic Study in Myelodysplastic Syndrome Patients.

    Science.gov (United States)

    Palomo, Laura; Fuster-Tormo, Francisco; Alvira, Daniel; Ademà, Vera; Armengol, María Pilar; Gómez-Marzo, Paula; de Haro, Nuri; Mallo, Mar; Xicoy, Blanca; Zamora, Lurdes; Solé, Francesc

    2017-08-01

    Whole genome amplification (WGA) has become an invaluable method for preserving limited samples of precious stock material and has been used during the past years as an alternative tool to increase the amount of DNA before library preparation for next-generation sequencing. Myelodysplastic syndromes (MDS) are a group of clonal hematopoietic stem cell disorders characterized by presenting somatic mutations in several myeloid-related genes. In this work, targeted deep sequencing has been performed on four paired fresh DNA and WGA DNA samples from bone marrow of MDS patients, to assess the feasibility of using WGA DNA for detecting somatic mutations. The results of this study highlighted that, in general, the sequencing and alignment statistics of fresh DNA and WGA DNA samples were similar. However, after variant calling and when considering variants detected at all frequencies, there was a high level of discordance between fresh DNA and WGA DNA (overall, a higher number of variants was detected in WGA DNA). After proper filtering, a total of three somatic mutations were detected in the cohort. All somatic mutations detected in fresh DNA were also identified in WGA DNA and validated by whole exome sequencing.

  6. Customer-Provider Strategic Alignment: A Maturity Model

    Science.gov (United States)

    Luftman, Jerry; Brown, Carol V.; Balaji, S.

    This chapter presents a new model for assessing the maturity of a ­customer-provider relationship from a collaborative service delivery perspective: the Customer-Provider Strategic Alignment Maturity (CPSAM) Model. This model builds on recent research for effectively managing the customer-provider relationship in IT service outsourcing contexts and a validated model for assessing alignment across internal IT service units and their business customers within the same organization. After reviewing relevant literature by service science and information systems researchers, the six overarching components of the maturity model are presented: value measurements, governance, partnership, communications, human resources and skills, and scope and architecture. A key assumption of the model is that all of the components need be addressed to assess and improve customer-provider alignment. Examples of specific metrics for measuring the maturity level of each component over the five levels of maturity are also presented.

  7. Simulation of beamline alignment operations

    International Nuclear Information System (INIS)

    Annese, C; Miller, M G.

    1999-01-01

    The CORBA-based Simulator was a Laboratory Directed Research and Development (LDRD) project that applied simulation techniques to explore critical questions about distributed control systems. The simulator project used a three-prong approach that studied object-oriented distribution tools, computer network modeling, and simulation of key control system scenarios. The National Ignition Facility's (NIF) optical alignment system was modeled to study control system operations. The alignment of NIF's 192 beamlines is a large complex operation involving more than 100 computer systems and 8000 mechanized devices. The alignment process is defined by a detailed set of procedures; however, many of the steps are deterministic. The alignment steps for a poorly aligned component are similar to that of a nearly aligned component; however, additional operations/iterations are required to complete the process. Thus, the same alignment operations will require variable amounts of time to perform depending on the current alignment condition as well as other factors. Simulation of the alignment process is necessary to understand beamline alignment time requirements and how shared resources such as the Output Sensor and Target Alignment Sensor effect alignment efficiency. The simulation has provided alignment time estimates and other results based on documented alignment procedures and alignment experience gained in the laboratory. Computer communication time, mechanical hardware actuation times, image processing algorithm execution times, etc. have been experimentally determined and incorporated into the model. Previous analysis of alignment operations utilized average implementation times for all alignment operations. Resource sharing becomes rather simple to model when only average values are used. The time required to actually implement the many individual alignment operations will be quite dynamic. The simulation model estimates the time to complete an operation using

  8. CAB-Align: A Flexible Protein Structure Alignment Method Based on the Residue-Residue Contact Area.

    Directory of Open Access Journals (Sweden)

    Genki Terashi

    Full Text Available Proteins are flexible, and this flexibility has an essential functional role. Flexibility can be observed in loop regions, rearrangements between secondary structure elements, and conformational changes between entire domains. However, most protein structure alignment methods treat protein structures as rigid bodies. Thus, these methods fail to identify the equivalences of residue pairs in regions with flexibility. In this study, we considered that the evolutionary relationship between proteins corresponds directly to the residue-residue physical contacts rather than the three-dimensional (3D coordinates of proteins. Thus, we developed a new protein structure alignment method, contact area-based alignment (CAB-align, which uses the residue-residue contact area to identify regions of similarity. The main purpose of CAB-align is to identify homologous relationships at the residue level between related protein structures. The CAB-align procedure comprises two main steps: First, a rigid-body alignment method based on local and global 3D structure superposition is employed to generate a sufficient number of initial alignments. Then, iterative dynamic programming is executed to find the optimal alignment. We evaluated the performance and advantages of CAB-align based on four main points: (1 agreement with the gold standard alignment, (2 alignment quality based on an evolutionary relationship without 3D coordinate superposition, (3 consistency of the multiple alignments, and (4 classification agreement with the gold standard classification. Comparisons of CAB-align with other state-of-the-art protein structure alignment methods (TM-align, FATCAT, and DaliLite using our benchmark dataset showed that CAB-align performed robustly in obtaining high-quality alignments and generating consistent multiple alignments with high coverage and accuracy rates, and it performed extremely well when discriminating between homologous and nonhomologous pairs of proteins

  9. CAB-Align: A Flexible Protein Structure Alignment Method Based on the Residue-Residue Contact Area.

    Science.gov (United States)

    Terashi, Genki; Takeda-Shitaka, Mayuko

    2015-01-01

    Proteins are flexible, and this flexibility has an essential functional role. Flexibility can be observed in loop regions, rearrangements between secondary structure elements, and conformational changes between entire domains. However, most protein structure alignment methods treat protein structures as rigid bodies. Thus, these methods fail to identify the equivalences of residue pairs in regions with flexibility. In this study, we considered that the evolutionary relationship between proteins corresponds directly to the residue-residue physical contacts rather than the three-dimensional (3D) coordinates of proteins. Thus, we developed a new protein structure alignment method, contact area-based alignment (CAB-align), which uses the residue-residue contact area to identify regions of similarity. The main purpose of CAB-align is to identify homologous relationships at the residue level between related protein structures. The CAB-align procedure comprises two main steps: First, a rigid-body alignment method based on local and global 3D structure superposition is employed to generate a sufficient number of initial alignments. Then, iterative dynamic programming is executed to find the optimal alignment. We evaluated the performance and advantages of CAB-align based on four main points: (1) agreement with the gold standard alignment, (2) alignment quality based on an evolutionary relationship without 3D coordinate superposition, (3) consistency of the multiple alignments, and (4) classification agreement with the gold standard classification. Comparisons of CAB-align with other state-of-the-art protein structure alignment methods (TM-align, FATCAT, and DaliLite) using our benchmark dataset showed that CAB-align performed robustly in obtaining high-quality alignments and generating consistent multiple alignments with high coverage and accuracy rates, and it performed extremely well when discriminating between homologous and nonhomologous pairs of proteins in both

  10. Investigating conversational dynamics: Interactive alignment, Interpersonal synergy, and collective task performance

    DEFF Research Database (Denmark)

    Fusaroli, Riccardo; Tylén, Kristian

    2016-01-01

    This study investigates interpersonal processes underlying dialog by comparing two approaches, interactive alignment and interpersonal synergy, and assesses how they predict collective performance in a joint task. While the interactive alignment approach highlights imitative patterns between...... and their impact on collective performance in a corpus of task-oriented conversations. The results show statistical presence of patterns relevant for both approaches. However, synergetic aspects of dialog provide the best statistical predictors of collective performance and adding aspects of the alignment approach...... does not improve the model. This suggests that structural organization at the level of the interaction plays a crucial role in task-oriented conversations, possibly constraining and integrating processes related to alignment....

  11. BinAligner: a heuristic method to align biological networks.

    Science.gov (United States)

    Yang, Jialiang; Li, Jun; Grünewald, Stefan; Wan, Xiu-Feng

    2013-01-01

    The advances in high throughput omics technologies have made it possible to characterize molecular interactions within and across various species. Alignments and comparison of molecular networks across species will help detect orthologs and conserved functional modules and provide insights on the evolutionary relationships of the compared species. However, such analyses are not trivial due to the complexity of network and high computational cost. Here we develop a mixture of global and local algorithm, BinAligner, for network alignments. Based on the hypotheses that the similarity between two vertices across networks would be context dependent and that the information from the edges and the structures of subnetworks can be more informative than vertices alone, two scoring schema, 1-neighborhood subnetwork and graphlet, were introduced to derive the scoring matrices between networks, besides the commonly used scoring scheme from vertices. Then the alignment problem is formulated as an assignment problem, which is solved by the combinatorial optimization algorithm, such as the Hungarian method. The proposed algorithm was applied and validated in aligning the protein-protein interaction network of Kaposi's sarcoma associated herpesvirus (KSHV) and that of varicella zoster virus (VZV). Interestingly, we identified several putative functional orthologous proteins with similar functions but very low sequence similarity between the two viruses. For example, KSHV open reading frame 56 (ORF56) and VZV ORF55 are helicase-primase subunits with sequence identity 14.6%, and KSHV ORF75 and VZV ORF44 are tegument proteins with sequence identity 15.3%. These functional pairs can not be identified if one restricts the alignment into orthologous protein pairs. In addition, BinAligner identified a conserved pathway between two viruses, which consists of 7 orthologous protein pairs and these proteins are connected by conserved links. This pathway might be crucial for virus packing and

  12. Relation between Nd2Fe14B grain alignment and coercive force decrease ratio in NdFeB sintered magnets

    International Nuclear Information System (INIS)

    Matsuura, Yutaka; Hoshijima, Jun; Ishii, Rintaro

    2013-01-01

    It was found that the coercive force of NdFeB sintered magnets decreases as the Nd 2 Fe 14 B grain alignment improves. Because of this phenomenon, studies looked at the relation between this alignment and the coercive force decrease ratio. In experiments, it was expected that the coercive force of perfectly aligned magnet reached 0.7 of coercive force in istotropically aligned magnet. When it is postulated that the coercive force is determined by the Stoner–Wohlfarth model, coercive force increases as the alignment improves and it becomes difficult to explain our experimental data. On the other hand, when the coercive force is determined by magnetic domain wall motion, the coercive force decreases as the alignment improves and the coercive force of the perfectly aligned magnet reaches 1/√(2) of the isotropically aligned magnet. This tendency and value was very close to our data. It strongly suggests that the coercive force of NdFeB sintered magnets is determined by the domain wall motion. - Highlights: ► Coercive force of NdFeB sintered magnets decreases as grains alignment improves. ► Coercive force decrease ratio reaches −30% at the perfect aligned magnet. ►These experimental results are different from the Stoner–Wohlfarth model. ► The magnetic domain wall motion could explain this coercive force decrease ratio

  13. Improved technique that allows the performance of large-scale SNP genotyping on DNA immobilized by FTA technology.

    Science.gov (United States)

    He, Hongbin; Argiro, Laurent; Dessein, Helia; Chevillard, Christophe

    2007-01-01

    FTA technology is a novel method designed to simplify the collection, shipment, archiving and purification of nucleic acids from a wide variety of biological sources. The number of punches that can normally be obtained from a single specimen card are often however, insufficient for the testing of the large numbers of loci required to identify genetic factors that control human susceptibility or resistance to multifactorial diseases. In this study, we propose an improved technique to perform large-scale SNP genotyping. We applied a whole genome amplification method to amplify DNA from buccal cell samples stabilized using FTA technology. The results show that using the improved technique it is possible to perform up to 15,000 genotypes from one buccal cell sample. Furthermore, the procedure is simple. We consider this improved technique to be a promising methods for performing large-scale SNP genotyping because the FTA technology simplifies the collection, shipment, archiving and purification of DNA, while whole genome amplification of FTA card bound DNA produces sufficient material for the determination of thousands of SNP genotypes.

  14. Structure and mechanism of human DNA polymerase [eta

    Energy Technology Data Exchange (ETDEWEB)

    Biertümpfel, Christian; Zhao, Ye; Kondo, Yuji; Ramón-Maiques, Santiago; Gregory, Mark; Lee, Jae Young; Masutani, Chikahide; Lehmann, Alan R.; Hanaoka, Fumio; Yang, Wei (Sussex); (NIH); (Gakushuin); (Osaka)

    2010-11-03

    The variant form of the human syndrome xeroderma pigmentosum (XPV) is caused by a deficiency in DNA polymerase {eta} (Pol{eta}), a DNA polymerase that enables replication through ultraviolet-induced pyrimidine dimers. Here we report high-resolution crystal structures of human Pol{eta} at four consecutive steps during DNA synthesis through cis-syn cyclobutane thymine dimers. Pol{eta} acts like a 'molecular splint' to stabilize damaged DNA in a normal B-form conformation. An enlarged active site accommodates the thymine dimer with excellent stereochemistry for two-metal ion catalysis. Two residues conserved among Pol{eta} orthologues form specific hydrogen bonds with the lesion and the incoming nucleotide to assist translesion synthesis. On the basis of the structures, eight Pol{eta} missense mutations causing XPV can be rationalized as undermining the molecular splint or perturbing the active-site alignment. The structures also provide an insight into the role of Pol{eta} in replicating through D loop and DNA fragile sites.

  15. A new prosthetic alignment device to read and record prosthesis alignment data.

    Science.gov (United States)

    Pirouzi, Gholamhossein; Abu Osman, Noor Azuan; Ali, Sadeeq; Davoodi Makinejad, Majid

    2017-12-01

    Prosthetic alignment is an essential process to rehabilitate patients with amputations. This study presents, for the first time, an invented device to read and record prosthesis alignment data. The digital device consists of seven main parts: the trigger, internal shaft, shell, sensor adjustment button, digital display, sliding shell, and tip. The alignment data were read and recorded by the user or a computer to replicate prosthesis adjustment for future use or examine the sequence of changes in alignment and its effect on the posture of the patient. Alignment data were recorded at the anterior/posterior and medial/lateral positions for five patients. Results show the high level of confidence to record alignment data and replicate adjustments. Therefore, the device helps patients readjust their prosthesis by themselves, or prosthetists to perform adjustment for patients and analyze the effects of malalignment.

  16. RNA-Pareto: interactive analysis of Pareto-optimal RNA sequence-structure alignments.

    Science.gov (United States)

    Schnattinger, Thomas; Schöning, Uwe; Marchfelder, Anita; Kestler, Hans A

    2013-12-01

    Incorporating secondary structure information into the alignment process improves the quality of RNA sequence alignments. Instead of using fixed weighting parameters, sequence and structure components can be treated as different objectives and optimized simultaneously. The result is not a single, but a Pareto-set of equally optimal solutions, which all represent different possible weighting parameters. We now provide the interactive graphical software tool RNA-Pareto, which allows a direct inspection of all feasible results to the pairwise RNA sequence-structure alignment problem and greatly facilitates the exploration of the optimal solution set.

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

    Directory of Open Access Journals (Sweden)

    Qi Zheng

    2016-10-01

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

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

    Science.gov (United States)

    Zheng, Qi; Grice, Elizabeth A

    2016-10-01

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

  19. Improved protocols to accelerate the assembly of DNA barcode reference libraries for freshwater zooplankton.

    Science.gov (United States)

    Elías-Gutiérrez, Manuel; Valdez-Moreno, Martha; Topan, Janet; Young, Monica R; Cohuo-Colli, José Angel

    2018-03-01

    Currently, freshwater zooplankton sampling and identification methodologies have remained virtually unchanged since they were first established in the beginning of the XX century. One major contributing factor to this slow progress is the limited success of modern genetic methodologies, such as DNA barcoding, in several of the main groups. This study demonstrates improved protocols which enable the rapid assessment of most animal taxa inhabiting any freshwater system by combining the use of light traps, careful fixation at low temperatures using ethanol, and zooplankton-specific primers. We DNA-barcoded 2,136 specimens from a diverse array of taxonomic assemblages (rotifers, mollusks, mites, crustaceans, insects, and fishes) from several Canadian and Mexican lakes with an average sequence success rate of 85.3%. In total, 325 Barcode Index Numbers (BINs) were detected with only three BINs (two cladocerans and one copepod) shared between Canada and Mexico, suggesting a much narrower distribution range of freshwater zooplankton than previously thought. This study is the first to broadly explore the metazoan biodiversity of freshwater systems with DNA barcodes to construct a reference library that represents the first step for future programs which aim to monitor ecosystem health, track invasive species, or improve knowledge of the ecology and distribution of freshwater zooplankton.

  20. Improving mass measurement accuracy in mass spectrometry based proteomics by combining open source tools for chromatographic alignment and internal calibration.

    Science.gov (United States)

    Palmblad, Magnus; van der Burgt, Yuri E M; Dalebout, Hans; Derks, Rico J E; Schoenmaker, Bart; Deelder, André M

    2009-05-02

    Accurate mass determination enhances peptide identification in mass spectrometry based proteomics. We here describe the combination of two previously published open source software tools to improve mass measurement accuracy in Fourier transform ion cyclotron resonance mass spectrometry (FTICRMS). The first program, msalign, aligns one MS/MS dataset with one FTICRMS dataset. The second software, recal2, uses peptides identified from the MS/MS data for automated internal calibration of the FTICR spectra, resulting in sub-ppm mass measurement errors.

  1. Electrostatic assembly of Cu2O nanoparticles on DNA templates

    International Nuclear Information System (INIS)

    Wang Li; Wei Gang; Qi Bin; Zhou Hualan; Liu Zhiguo; Song Yonghai; Yang Xiurong; Li Zhuang

    2006-01-01

    In this paper, a method for highly ordered assembly of cuprous oxide (Cu 2 O) nanoparticles (NPs) by DNA templates was reported. Cetyltrimethylammonium bromide (CTAB)-capped Cu 2 O NPs were adsorbed onto well-aligned λ-DNA chains to form necklace-like one-dimensional (1D) nanostructures. UV-vis, atomic force microscopy (AFM) and X-ray photoelectron spectroscopy (XPS) were used to characterize the nanostructure. The Cu 2 O nanostructures fabricated with the method are both highly ordered and quite straight

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

    Directory of Open Access Journals (Sweden)

    Bingxin Yang

    2006-03-01

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

  3. Adenovirus 36 DNA in human adipose tissue.

    Science.gov (United States)

    Ponterio, E; Cangemi, R; Mariani, S; Casella, G; De Cesare, A; Trovato, F M; Garozzo, A; Gnessi, L

    2015-12-01

    Recent studies have suggested a possible correlation between obesity and adenovirus 36 (Adv36) infection in humans. As information on adenoviral DNA presence in human adipose tissue are limited, we evaluated the presence of Adv36 DNA in adipose tissue of 21 adult overweight or obese patients. Total DNA was extracted from adipose tissue biopsies. Virus detection was performed using PCR protocols with primers against specific Adv36 fiber protein and the viral oncogenic E4orf1 protein nucleotide sequences. Sequences were aligned with the NCBI database and phylogenetic analyses were carried out with MEGA6 software. Adv36 DNA was found in four samples (19%). This study indicates that some individuals carry Adv36 in the visceral adipose tissue. Further studies are needed to determine the specific effect of Adv36 infection on adipocytes, the prevalence of Adv36 infection and its relationship with obesity in the perspective of developing a vaccine that could potentially prevent or mitigate infection.

  4. enDNA-Prot: Identification of DNA-Binding Proteins by Applying Ensemble Learning

    Directory of Open Access Journals (Sweden)

    Ruifeng Xu

    2014-01-01

    Full Text Available DNA-binding proteins are crucial for various cellular processes, such as recognition of specific nucleotide, regulation of transcription, and regulation of gene expression. Developing an effective model for identifying DNA-binding proteins is an urgent research problem. Up to now, many methods have been proposed, but most of them focus on only one classifier and cannot make full use of the large number of negative samples to improve predicting performance. This study proposed a predictor called enDNA-Prot for DNA-binding protein identification by employing the ensemble learning technique. Experiential results showed that enDNA-Prot was comparable with DNA-Prot and outperformed DNAbinder and iDNA-Prot with performance improvement in the range of 3.97–9.52% in ACC and 0.08–0.19 in MCC. Furthermore, when the benchmark dataset was expanded with negative samples, the performance of enDNA-Prot outperformed the three existing methods by 2.83–16.63% in terms of ACC and 0.02–0.16 in terms of MCC. It indicated that enDNA-Prot is an effective method for DNA-binding protein identification and expanding training dataset with negative samples can improve its performance. For the convenience of the vast majority of experimental scientists, we developed a user-friendly web-server for enDNA-Prot which is freely accessible to the public.

  5. Aligning Assessment and Instruction with State Standards for Children with Significant Disabilities

    Science.gov (United States)

    Parrish, Polly R.; Stodden, Robert A.

    2009-01-01

    This article presents a classroom teacher's perspective on one of the important requirements of the No Child Left Behind Act of 2001 (NCLB) legislation and aligned language found in the Individuals With Disabilities Education Improvement Act (IDEA 2004)--that of aligning assessment and instructional practices with state academic content standard…

  6. Mask alignment system for semiconductor processing

    Science.gov (United States)

    Webb, Aaron P.; Carlson, Charles T.; Weaver, William T.; Grant, Christopher N.

    2017-02-14

    A mask alignment system for providing precise and repeatable alignment between ion implantation masks and workpieces. The system includes a mask frame having a plurality of ion implantation masks loosely connected thereto. The mask frame is provided with a plurality of frame alignment cavities, and each mask is provided with a plurality of mask alignment cavities. The system further includes a platen for holding workpieces. The platen may be provided with a plurality of mask alignment pins and frame alignment pins configured to engage the mask alignment cavities and frame alignment cavities, respectively. The mask frame can be lowered onto the platen, with the frame alignment cavities moving into registration with the frame alignment pins to provide rough alignment between the masks and workpieces. The mask alignment cavities are then moved into registration with the mask alignment pins, thereby shifting each individual mask into precise alignment with a respective workpiece.

  7. Two-antenna GNSS Aided-INS Alignment Using Adaptive Control of Filter Noise Covariance

    Directory of Open Access Journals (Sweden)

    HAO Yushi

    2018-04-01

    Full Text Available This paper developed a theory of INS fine alignment in order to restrain the divergence of yaw angle,two antennas GNSS aided-INS integrated alignment algorithm was utilized.An attitude error measurement equation was conducted based on the relationship between baseline vectors calculated by two sensors and attitude error.The algorithm was executed by EKF using adaptive control of filter noise covariance.The experimental results showed that stability of the integrated system was improved under the system noise covariance adaptive control mechanism;The measurement noise covariance adaptive control mechanism can reduce the influence of measurement noise and improve the alignment absolute accuracy;Further improvement was achieved under the condition of minim bias of baseline length.The accuracy of roll and pitch was 0.02°,the accuracy of yaw was 0.04°.

  8. NAD(+) Replenishment Improves Lifespan and Healthspan in Ataxia Telangiectasia Models via Mitophagy and DNA Repair

    DEFF Research Database (Denmark)

    Fang, Evandro Fei; Kassahun, Henok; Croteau, Deborah L

    2016-01-01

    and neurodegeneration in A-T patients is unclear. Here we report and examine the significance of increased PARylation, low NAD(+), and mitochondrial dysfunction in ATM-deficient neurons, mice, and worms. Treatments that replenish intracellular NAD(+) reduce the severity of A-T neuropathology, normalize neuromuscular...... function, delay memory loss, and extend lifespan in both animal models. Mechanistically, treatments that increase intracellular NAD(+) also stimulate neuronal DNA repair and improve mitochondrial quality via mitophagy. This work links two major theories on aging, DNA damage accumulation, and mitochondrial...

  9. NAD+ Replenishment Improves Lifespan and Healthspan in Ataxia Telangiectasia Models via Mitophagy and DNA Repair.

    Science.gov (United States)

    Fang, Evandro Fei; Kassahun, Henok; Croteau, Deborah L; Scheibye-Knudsen, Morten; Marosi, Krisztina; Lu, Huiming; Shamanna, Raghavendra A; Kalyanasundaram, Sumana; Bollineni, Ravi Chand; Wilson, Mark A; Iser, Wendy B; Wollman, Bradley N; Morevati, Marya; Li, Jun; Kerr, Jesse S; Lu, Qiping; Waltz, Tyler B; Tian, Jane; Sinclair, David A; Mattson, Mark P; Nilsen, Hilde; Bohr, Vilhelm A

    2016-10-11

    Ataxia telangiectasia (A-T) is a rare autosomal recessive disease characterized by progressive neurodegeneration and cerebellar ataxia. A-T is causally linked to defects in ATM, a master regulator of the response to and repair of DNA double-strand breaks. The molecular basis of cerebellar atrophy and neurodegeneration in A-T patients is unclear. Here we report and examine the significance of increased PARylation, low NAD + , and mitochondrial dysfunction in ATM-deficient neurons, mice, and worms. Treatments that replenish intracellular NAD + reduce the severity of A-T neuropathology, normalize neuromuscular function, delay memory loss, and extend lifespan in both animal models. Mechanistically, treatments that increase intracellular NAD + also stimulate neuronal DNA repair and improve mitochondrial quality via mitophagy. This work links two major theories on aging, DNA damage accumulation, and mitochondrial dysfunction through nuclear DNA damage-induced nuclear-mitochondrial signaling, and demonstrates that they are important pathophysiological determinants in premature aging of A-T, pointing to therapeutic interventions. Published by Elsevier Inc.

  10. Ichthyophonus parasite phylogeny based on ITS rDNA structure prediction and alignment identifies six clades, with a single dominant marine type

    Science.gov (United States)

    Gregg, Jacob; Thompson, Rachel L.; Purcell, Maureen; Friedman, Carolyn S.; Hershberger, Paul

    2016-01-01

    Despite their widespread, global impact in both wild and cultured fishes, little is known of the diversity, transmission patterns, and phylogeography of parasites generally identified as Ichthyophonus. This study constructed a phylogeny based on the structural alignment of internal transcribed spacer (ITS) rDNA sequences to compare Ichthyophonus isolates from fish hosts in the Atlantic and Pacific oceans, and several rivers and aquaculture sites in North America, Europe, and Japan. Structure of the Ichthyophonus ITS1–5.8S–ITS2 transcript exhibited several homologies with other eukaryotes, and 6 distinct clades were identified within Ichthyophonus. A single clade contained a majority (71 of 98) of parasite isolations. This ubiquitous Ichthyophonus type occurred in 13 marine and anadromous hosts and was associated with epizootics in Atlantic herring, Chinook salmon, and American shad. A second clade contained all isolates from aquaculture, despite great geographic separation of the freshwater hosts. Each of the 4 remaining clades contained isolates from single host species. This study is the first to evaluate the genetic relationships among Ichthyophonus species across a significant portion of their host and geographic range. Additionally, parasite infection prevalence is reported in 16 fish species.

  11. Ichthyophonus parasite phylogeny based on ITS rDNA structure prediction and alignment identifies six clades, with a single dominant marine type.

    Science.gov (United States)

    Gregg, Jacob L; Powers, Rachel L; Purcell, Maureen K; Friedman, Carolyn S; Hershberger, Paul K

    2016-07-07

    Despite their widespread, global impact in both wild and cultured fishes, little is known of the diversity, transmission patterns, and phylogeography of parasites generally identified as Ichthyophonus. This study constructed a phylogeny based on the structural alignment of internal transcribed spacer (ITS) rDNA sequences to compare Ichthyophonus isolates from fish hosts in the Atlantic and Pacific oceans, and several rivers and aquaculture sites in North America, Europe, and Japan. Structure of the Ichthyophonus ITS1-5.8S-ITS2 transcript exhibited several homologies with other eukaryotes, and 6 distinct clades were identified within Ichthyophonus. A single clade contained a majority (71 of 98) of parasite isolations. This ubiquitous Ichthyophonus type occurred in 13 marine and anadromous hosts and was associated with epizootics in Atlantic herring, Chinook salmon, and American shad. A second clade contained all isolates from aquaculture, despite great geographic separation of the freshwater hosts. Each of the 4 remaining clades contained isolates from single host species. This study is the first to evaluate the genetic relationships among Ichthyophonus species across a significant portion of their host and geographic range. Additionally, parasite infection prevalence is reported in 16 fish species.

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

    International Nuclear Information System (INIS)

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

    2009-01-01

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

  13. Improving Fiber Alignment in HARDI by Combining Contextual PDE Flow with Constrained Spherical Deconvolution.

    Directory of Open Access Journals (Sweden)

    J M Portegies

    Full Text Available We propose two strategies to improve the quality of tractography results computed from diffusion weighted magnetic resonance imaging (DW-MRI data. Both methods are based on the same PDE framework, defined in the coupled space of positions and orientations, associated with a stochastic process describing the enhancement of elongated structures while preserving crossing structures. In the first method we use the enhancement PDE for contextual regularization of a fiber orientation distribution (FOD that is obtained on individual voxels from high angular resolution diffusion imaging (HARDI data via constrained spherical deconvolution (CSD. Thereby we improve the FOD as input for subsequent tractography. Secondly, we introduce the fiber to bundle coherence (FBC, a measure for quantification of fiber alignment. The FBC is computed from a tractography result using the same PDE framework and provides a criterion for removing the spurious fibers. We validate the proposed combination of CSD and enhancement on phantom data and on human data, acquired with different scanning protocols. On the phantom data we find that PDE enhancements improve both local metrics and global metrics of tractography results, compared to CSD without enhancements. On the human data we show that the enhancements allow for a better reconstruction of crossing fiber bundles and they reduce the variability of the tractography output with respect to the acquisition parameters. Finally, we show that both the enhancement of the FODs and the use of the FBC measure on the tractography improve the stability with respect to different stochastic realizations of probabilistic tractography. This is shown in a clinical application: the reconstruction of the optic radiation for epilepsy surgery planning.

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

    Science.gov (United States)

    Lizotte, Todd E.

    2011-10-01

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

  15. Fluorescence quenching studies of potential-dependent DNA reorientation dynamics at glassy carbon electrode surfaces.

    Science.gov (United States)

    Li, Qin; Cui, Chenchen; Higgins, Daniel A; Li, Jun

    2012-09-05

    The potential-dependent reorientation dynamics of double-stranded DNA (ds-DNA) attached to planar glassy carbon electrode (GCE) surfaces were investigated. The orientation state of surface-bound ds-DNA was followed by monitoring the fluorescence from a 6-carboxyfluorescein (FAM6) fluorophore covalently linked to the distal end of the DNA. Positive potentials (i.e., +0.2 V vs open circuit potential, OCP) caused the ds-DNA to align parallel to the electrode surface, resulting in strong dipole-electrode quenching of FAM6 fluorescence. Switching of the GCE potential to negative values (i.e., -0.2 V vs OCP) caused the ds-DNA to reorient perpendicular to the electrode surface, with a concomitant increase in FAM6 fluorescence. In addition to the very fast (submilliseconds) dynamics of the initial reorientation process, slow (0.1-0.9 s) relaxation of FAM6 fluorescence to intermediate levels was also observed after potential switching. These dynamics have not been previously described in the literature. They are too slow to be explained by double layer charging, and chronoamperometry data showed no evidence of such effects. Both the amplitude and rate of the dynamics were found to depend upon buffer concentration, and ds-DNA length, demonstrating a dependence on the double layer field. The dynamics are concluded to arise from previously undetected complexities in the mechanism of potential-dependent ds-DNA reorientation. The possible origins of these dynamics are discussed. A better understanding of these dynamics will lead to improved models for potential-dependent ds-DNA reorientation at electrode surfaces and will facilitate the development of advanced electrochemical devices for detection of target DNAs.

  16. An improved protocol and a new grinding device for extraction of genomic DNA from microorganisms by a two-step extraction procedure.

    Science.gov (United States)

    Zhang, S S; Chen, D; Lu, Q

    2012-05-21

    Current protocols to extract genomic DNA from microorganisms are still laborious, tedious and costly, especially for the species with thick cell walls. In order to improve the effectiveness of extracting DNA from microbial samples, a novel protocol, defined as two-step extraction method, along with an improved tissue-grinding device, was developed. The protocol included two steps, disruption of microbial cells or spores by grinding the sample together with silica sand in a new device and extraction of DNA with an effective buffer containing cell lysis chemicals. The device was prepared by using a commercial electric mini-grinder, adapted with a grinding stone, and a sample cup processed by lathing from a polytetrafluoroethylene rod. We tested the method with vegetative cells of four microbial species and two microbial spores that have thick cell walls and are therefore hard to process; these included Escherichia coli JM109, Bacillus subtilis WB600, Sacchromyces cerevisiae INVSc1, Trichoderma viride AS3.3711, and the spores of S. cerevisiae and T. viride, respectively, representing Gram-positive bacteria, Gram-negative bacteria, yeast, filamentous fungi. We found that this new method and device extracted usable quantities of genomic DNA from the samples. The DNA fragments that were extracted exceeded 23 kb. The target sequences up to about 5 kb were successfully and exclusively amplified by PCR using extracted DNA as the template. In addition, the DNA extraction was finalized within 1.5 h. Thus, we conclude that this two-step extraction method is an effective and improved protocol for extraction of genomic DNA from microbial samples.

  17. Complete sequence analysis of 18S rDNA based on genomic DNA extraction from individual Demodex mites (Acari: Demodicidae).

    Science.gov (United States)

    Zhao, Ya-E; Xu, Ji-Ru; Hu, Li; Wu, Li-Ping; Wang, Zheng-Hang

    2012-05-01

    The study for the first time attempted to accomplish 18S ribosomal DNA (rDNA) complete sequence amplification and analysis for three Demodex species (Demodex folliculorum, Demodex brevis and Demodex canis) based on gDNA extraction from individual mites. The mites were treated by DNA Release Additive and Hot Start II DNA Polymerase so as to promote mite disruption and increase PCR specificity. Determination of D. folliculorum gDNA showed that the gDNA yield reached the highest at 1 mite, tending to descend with the increase of mite number. The individual mite gDNA was successfully used for 18S rDNA fragment (about 900 bp) amplification examination. The alignments of 18S rDNA complete sequences of individual mite samples and those of pooled mite samples ( ≥ 1000mites/sample) showed over 97% identities for each species, indicating that the gDNA extracted from a single individual mite was as satisfactory as that from pooled mites for PCR amplification. Further pairwise sequence analyses showed that average divergence, genetic distance, transition/transversion or phylogenetic tree could not effectively identify the three Demodex species, largely due to the differentiation in the D. canis isolates. It can be concluded that the individual Demodex mite gDNA can satisfy the molecular study of Demodex. 18S rDNA complete sequence is suitable for interfamily identification in Cheyletoidea, but whether it is suitable for intrafamily identification cannot be confirmed until the ascertainment of the types of Demodex mites parasitizing in dogs. Copyright © 2012 Elsevier Inc. All rights reserved.

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

    Science.gov (United States)

    Lee, Hui Sun; Im, Wonpil

    2013-01-01

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

  19. Correction of severe tooth rotations using clear aligners: a case report.

    Science.gov (United States)

    Frongia, Gianluigi; Castroflorio, Tommaso

    2012-11-01

    The present adult patient case report shows the correction of a crossbite malocclusion and severe tooth rotations treated with the Invisalign system. A 27-year-old female with a dental crossbite (24, 34), severe rotations of two lower incisors (more than 40 degrees) and malalignment of the upper and lower arches is described. The Invisalign system was treatment planned to correct the malocclusion. The treatment goals of crossbite, rotation and malalignment correction were achieved after 12 months of active aligner therapy. The overbite improved (2.5 mm before treatment, 1 mm at the end); the dental crossbite, the crowding and the severe tooth rotations (with a mean of 2 degrees of improvement per aligner) were corrected. After treatment, the dental alignment was considered excellent. The presented case indicates that the Invisalign system can be a useful appliance to correct a dental malocclusion involving severe rotations.

  20. Improving alignment in Tract-based spatial statistics: evaluation and optimization of image registration.

    Science.gov (United States)

    de Groot, Marius; Vernooij, Meike W; Klein, Stefan; Ikram, M Arfan; Vos, Frans M; Smith, Stephen M; Niessen, Wiro J; Andersson, Jesper L R

    2013-08-01

    Anatomical alignment in neuroimaging studies is of such importance that considerable effort is put into improving the registration used to establish spatial correspondence. Tract-based spatial statistics (TBSS) is a popular method for comparing diffusion characteristics across subjects. TBSS establishes spatial correspondence using a combination of nonlinear registration and a "skeleton projection" that may break topological consistency of the transformed brain images. We therefore investigated feasibility of replacing the two-stage registration-projection procedure in TBSS with a single, regularized, high-dimensional registration. To optimize registration parameters and to evaluate registration performance in diffusion MRI, we designed an evaluation framework that uses native space probabilistic tractography for 23 white matter tracts, and quantifies tract similarity across subjects in standard space. We optimized parameters for two registration algorithms on two diffusion datasets of different quality. We investigated reproducibility of the evaluation framework, and of the optimized registration algorithms. Next, we compared registration performance of the regularized registration methods and TBSS. Finally, feasibility and effect of incorporating the improved registration in TBSS were evaluated in an example study. The evaluation framework was highly reproducible for both algorithms (R(2) 0.993; 0.931). The optimal registration parameters depended on the quality of the dataset in a graded and predictable manner. At optimal parameters, both algorithms outperformed the registration of TBSS, showing feasibility of adopting such approaches in TBSS. This was further confirmed in the example experiment. Copyright © 2013 Elsevier Inc. All rights reserved.

  1. Development, applications and distribution of DNA markers for genetic information for sorghum and maize improvement

    International Nuclear Information System (INIS)

    Lee, M.

    2001-01-01

    This final report summarizes the progress made towards the enhancement and distribution of genetic resources (e.g. genetic stocks, seed and DNA clones) used for basic and applied aspects of the genetic improvement of maize and sorghum. The genetic maps of maize and sorghum were improved through comparative mapping of RFLP loci detected by 124 maize cDNA clones and through the development of a new mapping population of maize. Comparative mapping between maize and sorghum and maize and rice, using the set of 124 maize cDNA clones (and other clones) in each study, substantiated previous observations of extensive conservation of locus order but it also provided strong evidence of numerous large-scale chromosomal rearrangements. The new mapping population for maize (intermated B73xMo17, 'IBM') was created by random intermating during the first segregating generation. Intermating for four generations prior to the derivation of recombinant inbred lines (RILs) increased the frequency of recombinants at many regions of the maize genome and provided better genetic resolution of locus order. Expansion of the maize genetic map was not uniform along the length of a linkage group and was less than the theoretical expectation. The 350 IBM RILs were genotyped at 512 loci detected by DNA clones, including 76 of the 124 supported by this contract. The production of the sorghum mapping population of RILs from the cross CK60xPI229828 has been delayed by weather conditions that were not conducive to plant growth and seed development. Seed of the IBM RILs have been distributed (approximately 5000 RILs in total) to 16 research organizations in the public and private sector. The DNA clones have been distributed (1,206 in total) to nine research labs. Further distribution of the seed and clones will be managed by curators at stock centers in the public domain. (author)

  2. High yield growth of patterned vertically aligned carbon nanotubes using inkjet-printed catalyst.

    Science.gov (United States)

    Beard, James D; Stringer, Jonathan; Ghita, Oana R; Smith, Patrick J

    2013-10-09

    This study reports on the fabrication of vertically aligned carbon nanotubes localized at specific sites on a growth substrate by deposition of a nanoparticle suspension using inkjet printing. Carbon nanotubes were grown with high yield as vertically aligned forests to a length of approximately 400 μm. The use of inkjet printing for catalyst fabrication considerably improves the production rate of vertically aligned patterned nanotube forests compared with conventional patterning techniques, for example, electron beam lithography or photolithography.

  3. Sagittal alignment after single cervical disc arthroplasty.

    Science.gov (United States)

    Guérin, Patrick; Obeid, Ibrahim; Gille, Olivier; Bourghli, Anouar; Luc, Stéphane; Pointillart, Vincent; Vital, Jean-Marc

    2012-02-01

    Prospective study. To analyze the sagittal balance after single-level cervical disc replacement (CDR) and range of motion (ROM). To define clinical and radiologic parameters those have a significant correlation with segmental and overall cervical curvature after CDR. Clinical outcomes and ROM after CDR with Mobi-C (LDR, Troyes, France) prosthesis have been documented in few studies. No earlier report of this prosthesis has studied correlations between static and dynamic parameters or those between static parameters and clinical outcomes. Forty patients were evaluated. Clinical outcome was assessed using the Short Form-36 questionnaire, Neck Disability Index, and a Visual Analog Scale. Spineview software (Surgiview, Paris, France) was used to investigate sagittal balance parameters and ROM. The mean follow-up was 24.3 months (range: 12 to 36 mo). Clinical outcomes were satisfactory. There was a significant improvement of Short Form-36, Neck Disability Index, and Visual Analog Scale scores. Mean ROM was 8.3 degrees preoperatively and 11.0 degrees postoperatively (P=0.013). Mean preoperative C2C7 curvature was 12.8 and 16.0 degrees at last follow-up (P=0.001). Mean preoperative functional spinal unit (FSU) angle was 2.3 and 5.3 degrees postoperatively (P<0.0001). Mean postoperative shell angle was 5.5 degrees. There was a significant correlation between postoperative C2C7 alignment and preoperative C2C7 alignment, change of C2C7 alignment, preoperative and postoperative FSU angle, and prosthesis shell angle. There was also a significant correlation between postoperative FSU angle and preoperative C2C7 alignment, preoperative FSU angle, change of FSU angle, and prosthesis shell angle. Regression analysis showed that prosthesis shell angle and preoperative FSU angle contributed significantly to postoperative FSU angle. Moreover, preoperative C2C7 alignment, preoperative FSU angle, postoperative FSU angle, and prosthesis shell angle contributed significantly to

  4. A new correlation based alignment technique for use in electron tomography

    International Nuclear Information System (INIS)

    Jones, S.D.; Härting, M.

    2013-01-01

    In this paper we present a new correlation based method for the alignment of a single axis tilt series. Rather than performing the pairwise correlation procedure with the central image as the starting point, the method presented here calculates the optimal starting position within the tilt series and proceeds towards both ends. The starting position is determined by maximisation of a viability function, J, which rewards cumulative series correlation and penalises both cumulative series shift and distance from the centre of the image series. - Highlights: • Pairwise correlation based alignment is investigated as a function of seed position. • It is shown that the convention of using the central image as the seed is not optimal. • A function is proposed which improves alignment by finding the optimal seed position. • The method is found to produce alignment with lower residual scores with the phantom data. • Superior alignment is produced vs the standard method with the experimental data

  5. Identification of Forensic Samples via Mitochondrial DNA in the Undergraduate Biochemistry Laboratory

    Science.gov (United States)

    Millard, Julie T.; Pilon, André M.

    2003-04-01

    A recent forensic approach for identification of unknown biological samples is mitochondrial DNA (mtDNA) sequencing. We describe a laboratory exercise suitable for an undergraduate biochemistry course in which the polymerase chain reaction is used to amplify a 440 base pair hypervariable region of human mtDNA from a variety of "crime scene" samples (e.g., teeth, hair, nails, cigarettes, envelope flaps, toothbrushes, and chewing gum). Amplification is verified via agarose gel electrophoresis and then samples are subjected to cycle sequencing. Sequence alignments are made via the program CLUSTAL W, allowing students to compare samples and solve the "crime."

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

    Directory of Open Access Journals (Sweden)

    Yanhua Song

    2017-01-01

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

  7. Electrostatic assembly of CTAB-capped silver nanoparticles along predefined λ-DNA template

    International Nuclear Information System (INIS)

    Wei Gang; Wang Li; Zhou Hualan; Liu Zhiguo; Song Yonghai; Li Zhuang

    2005-01-01

    Cetyltrimethylammonium bromide (CTAB)-capped positively-charged silver nanoparticles synthesized in water-ethanol system was electrostatic assembled on predefined aligned λ-DNA template. Silver nanowire can be obtained by changing the reaction time and the particles concentration. In our work, the length of the silver nanowire obtained is about 10 μm, and the dimension of the wires is about 20 nm. AFM data reveal that the assembly of CTAB-capped silver nanoparticles on DNA is ordered, but there is space between two particles absorbed on the DNA template. X-ray photoelectron spectroscopy (XPS) was applied to characterize the linear silver clusters, which provides an additional proof that the silver particles were assembled onto DNA template with fine order

  8. Clear aligners in orthodontic treatment.

    Science.gov (United States)

    Weir, T

    2017-03-01

    Since the introduction of the Tooth Positioner (TP Orthodontics) in 1944, removable appliances analogous to clear aligners have been employed for mild to moderate orthodontic tooth movements. Clear aligner therapy has been a part of orthodontic practice for decades, but has, particularly since the introduction of Invisalign appliances (Align Technology) in 1998, become an increasingly common addition to the orthodontic armamentarium. An internet search reveals at least 27 different clear aligner products currently on offer for orthodontic treatment. The present paper will highlight the increasing popularity of clear aligner appliances, as well as the clinical scope and the limitations of aligner therapy in general. Further, the paper will outline the differences between the various types of clear aligner products currently available. © 2017 Australian Dental Association.

  9. Relation between Nd{sub 2}Fe{sub 14}B grain alignment and coercive force decrease ratio in NdFeB sintered magnets

    Energy Technology Data Exchange (ETDEWEB)

    Matsuura, Yutaka, E-mail: Yutaka_Matsuura@hitachi-metals.co.jp [Hitachi Metals Ltd., NEOMAX Division, 2-15-17 Egawa, Shimamoto-cho, Mishima-gun, Osaka 618-0013 (Japan); Hoshijima, Jun; Ishii, Rintaro [Hitachi Metals Ltd., NEOMAX Division, 2-15-17 Egawa, Shimamoto-cho, Mishima-gun, Osaka 618-0013 (Japan)

    2013-06-15

    It was found that the coercive force of NdFeB sintered magnets decreases as the Nd{sub 2}Fe{sub 14}B grain alignment improves. Because of this phenomenon, studies looked at the relation between this alignment and the coercive force decrease ratio. In experiments, it was expected that the coercive force of perfectly aligned magnet reached 0.7 of coercive force in istotropically aligned magnet. When it is postulated that the coercive force is determined by the Stoner–Wohlfarth model, coercive force increases as the alignment improves and it becomes difficult to explain our experimental data. On the other hand, when the coercive force is determined by magnetic domain wall motion, the coercive force decreases as the alignment improves and the coercive force of the perfectly aligned magnet reaches 1/√(2) of the isotropically aligned magnet. This tendency and value was very close to our data. It strongly suggests that the coercive force of NdFeB sintered magnets is determined by the domain wall motion. - Highlights: ► Coercive force of NdFeB sintered magnets decreases as grains alignment improves. ► Coercive force decrease ratio reaches −30% at the perfect aligned magnet. ►These experimental results are different from the Stoner–Wohlfarth model. ► The magnetic domain wall motion could explain this coercive force decrease ratio.

  10. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    Gervasio Gomez

    2012-01-01

      The new alignment for the DT chambers has been successfully used in physics analysis starting with the 52X Global Tag. The remaining main areas of development over the next few months will be preparing a new track-based CSC alignment and producing realistic APEs (alignment position errors) and MC misalignment scenarios to match the latest muon alignment constants. Work on these items has been delayed from the intended timeline, mostly due to a large involvement of the muon alignment man-power in physics analyses over the first half of this year. As CMS keeps probing higher and higher energies, special attention must be paid to the reconstruction of very-high-energy muons. Recent muon POG reports from mid-June show a φ-dependence in curvature bias in Monte Carlo samples. This bias is observed already at the tracker level, where it is constant with muon pT, while it grows with pT as muon chamber information is added to the tracks. Similar studies show a much smaller effect in data, at le...

  11. Parasail: SIMD C library for global, semi-global, and local pairwise sequence alignments.

    Science.gov (United States)

    Daily, Jeff

    2016-02-10

    Sequence alignment algorithms are a key component of many bioinformatics applications. Though various fast Smith-Waterman local sequence alignment implementations have been developed for x86 CPUs, most are embedded into larger database search tools. In addition, fast implementations of Needleman-Wunsch global sequence alignment and its semi-global variants are not as widespread. This article presents the first software library for local, global, and semi-global pairwise intra-sequence alignments and improves the performance of previous intra-sequence implementations. A faster intra-sequence local pairwise alignment implementation is described and benchmarked, including new global and semi-global variants. Using a 375 residue query sequence a speed of 136 billion cell updates per second (GCUPS) was achieved on a dual Intel Xeon E5-2670 24-core processor system, the highest reported for an implementation based on Farrar's 'striped' approach. Rognes's SWIPE optimal database search application is still generally the fastest available at 1.2 to at best 2.4 times faster than Parasail for sequences shorter than 500 amino acids. However, Parasail was faster for longer sequences. For global alignments, Parasail's prefix scan implementation is generally the fastest, faster even than Farrar's 'striped' approach, however the opal library is faster for single-threaded applications. The software library is designed for 64 bit Linux, OS X, or Windows on processors with SSE2, SSE41, or AVX2. Source code is available from https://github.com/jeffdaily/parasail under the Battelle BSD-style license. Applications that require optimal alignment scores could benefit from the improved performance. For the first time, SIMD global, semi-global, and local alignments are available in a stand-alone C library.

  12. Pattern analysis of aligned nanowires in a microchannel

    International Nuclear Information System (INIS)

    Jeon, Young Jin; Kang, Hyun Wook; Ko, Seung Hwan; Sung, Hyung Jin

    2013-01-01

    An image processing method for evaluating the quality of nanowire alignment in a microchannel is described. A solution containing nanowires flowing into a microchannel will tend to deposit the nanowires on the bottom surface of the channel via near-wall shear flows. The deposited nanowires generally form complex directional structures along the direction of flow, and the physical properties of these structures depend on the structural morphology, including the alignment quality. A quantitative analysis approach to characterizing the nanowire alignment is needed to estimate the useful features of the nanowire structures. This analysis consists of several image processing methods, including ridge detection, texton analysis and autocorrelation function (ACF) calculation. The ridge detection method improved the ACF by extracting nanowire frames 1–2 pixels in width. Dilation filters were introduced to permit a comparison of the ACF results calculated from different images, regardless of the nanowire orientation. An ACF based on the FFT was then calculated over a square interrogation window. The alignment angle probability distribution was obtained using texton analysis. Monte Carlo simulations of artificially generated images were carried out, and the new algorithm was applied to images collected using two types of microscopy. (paper)

  13. DNA looping by FokI: the impact of synapse geometry on loop topology at varied site orientations

    Science.gov (United States)

    Rusling, David A.; Laurens, Niels; Pernstich, Christian; Wuite, Gijs J. L.; Halford, Stephen E.

    2012-01-01

    Most restriction endonucleases, including FokI, interact with two copies of their recognition sequence before cutting DNA. On DNA with two sites they act in cis looping out the intervening DNA. While many restriction enzymes operate symmetrically at palindromic sites, FokI acts asymmetrically at a non-palindromic site. The directionality of its sequence means that two FokI sites can be bridged in either parallel or anti-parallel alignments. Here we show by biochemical and single-molecule biophysical methods that FokI aligns two recognition sites on separate DNA molecules in parallel and that the parallel arrangement holds for sites in the same DNA regardless of whether they are in inverted or repeated orientations. The parallel arrangement dictates the topology of the loop trapped between sites in cis: the loop from inverted sites has a simple 180° bend, while that with repeated sites has a convoluted 360° turn. The ability of FokI to act at asymmetric sites thus enabled us to identify the synapse geometry for sites in trans and in cis, which in turn revealed the relationship between synapse geometry and loop topology. PMID:22362745

  14. Noisy: Identification of problematic columns in multiple sequence alignments

    Directory of Open Access Journals (Sweden)

    Grünewald Stefan

    2008-06-01

    Full Text Available Abstract Motivation Sequence-based methods for phylogenetic reconstruction from (nucleic acid sequence data are notoriously plagued by two effects: homoplasies and alignment errors. Large evolutionary distances imply a large number of homoplastic sites. As most protein-coding genes show dramatic variations in substitution rates that are not uncorrelated across the sequence, this often leads to a patchwork pattern of (i phylogenetically informative and (ii effectively randomized regions. In highly variable regions, furthermore, alignment errors accumulate resulting in sometimes misleading signals in phylogenetic reconstruction. Results We present here a method that, based on assessing the distribution of character states along a cyclic ordering of the taxa, allows the identification of phylogenetically uninformative homoplastic sites in a multiple sequence alignment. Removal of these sites appears to improve the performance of phylogenetic reconstruction algorithms as measured by various indices of "tree quality". In particular, we obtain more stable trees due to the exclusion of phylogenetically incompatible sites that most likely represent strongly randomized characters. Software The computer program noisy implements this approach. It can be employed to improving phylogenetic reconstruction capability with quite a considerable success rate whenever (1 the average bootstrap support obtained from the original alignment is low, and (2 there are sufficiently many taxa in the data set – at least, say, 12 to 15 taxa. The software can be obtained under the GNU Public License from http://www.bioinf.uni-leipzig.de/Software/noisy/.

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

    International Nuclear Information System (INIS)

    Yang Zhengfan; Penczek, Pawel A.

    2008-01-01

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

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

    Science.gov (United States)

    Yang, Zhengfan; Penczek, Pawel A

    2008-08-01

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

  17. How accurate is anatomic limb alignment in predicting mechanical limb alignment after total knee arthroplasty?

    Science.gov (United States)

    Lee, Seung Ah; Choi, Sang-Hee; Chang, Moon Jong

    2015-10-27

    Anatomic limb alignment often differs from mechanical limb alignment after total knee arthroplasty (TKA). We sought to assess the accuracy, specificity, and sensitivity for each of three commonly used ranges for anatomic limb alignment (3-9°, 5-10° and 2-10°) in predicting an acceptable range (neutral ± 3°) for mechanical limb alignment after TKA. We also assessed whether the accuracy of anatomic limb alignment was affected by anatomic variation. This retrospective study included 314 primary TKAs. The alignment of the limb was measured with both anatomic and mechanical methods of measurement. We also measured anatomic variation, including the femoral bowing angle, tibial bowing angle, and neck-shaft angle of the femur. All angles were measured on the same full-length standing anteroposterior radiographs. The accuracy, specificity, and sensitivity for each range of anatomic limb alignment were calculated and compared using mechanical limb alignment as the reference standard. The associations between the accuracy of anatomic limb alignment and anatomic variation were also determined. The range of 2-10° for anatomic limb alignment showed the highest accuracy, but it was only 73 % (3-9°, 65 %; 5-10°, 67 %). The specificity of the 2-10° range was 81 %, which was higher than that of the other ranges (3-9°, 69 %; 5-10°, 67 %). However, the sensitivity of the 2-10° range to predict varus malalignment was only 16 % (3-9°, 35 %; 5-10°, 68 %). In addition, the sensitivity of the 2-10° range to predict valgus malalignment was only 43 % (3-9°, 71 %; 5-10°, 43 %). The accuracy of anatomical limb alignment was lower for knees with greater femoral (odds ratio = 1.2) and tibial (odds ratio = 1.2) bowing. Anatomic limb alignment did not accurately predict mechanical limb alignment after TKA, and its accuracy was affected by anatomic variation. Thus, alignment after TKA should be assessed by measuring mechanical alignment rather than anatomic

  18. Capture and alignment of phi29 viral particles in sub-40 nanometer porous alumina membranes.

    Science.gov (United States)

    Moon, Jeong-Mi; Akin, Demir; Xuan, Yi; Ye, Peide D; Guo, Peixuan; Bashir, Rashid

    2009-02-01

    Bacteriophage phi29 virus nanoparticles and its associated DNA packaging nanomotor can provide for novel possibilities towards the development of hybrid bio-nano structures. Towards the goal of interfacing the phi29 viruses and nanomotors with artificial micro and nanostructures, we fabricated nanoporous Anodic Aluminum Oxide (AAO) membranes with pore size of 70 nm and shrunk the pores to sub 40 nm diameter using atomic layer deposition (ALD) of Aluminum Oxide. We were able to capture and align particles in the anodized nanopores using two methods. Firstly, a functionalization and polishing process to chemically attach the particles in the inner surface of the pores was developed. Secondly, centrifugation of the particles was utilized to align them in the pores of the nanoporous membranes. In addition, when a mixture of empty capsids and packaged particles was centrifuged at specific speeds, it was found that the empty capsids deform and pass through 40 nm diameter pores whereas the particles packaged with DNA were mainly retained at the top surface of the nanoporous membranes. Fluorescence microscopy was used to verify the selective filtration of empty capsids through the nanoporous membranes.

  19. Strategic Alignment and New Product Development

    DEFF Research Database (Denmark)

    Acur, Nuran; Kandemir, Destan; Boer, Harry

    2012-01-01

    Strategic alignment is widely accepted as a prerequisite for a firm’s success, but insight into the role of alignment in, and its impact on, the new product evelopment (NPD) process and its performance is less well developed. Most publications on this topic either focus on one form of alignment...... of NPD performance indicators. Strategic planning and innovativeness appear to affect technological, market, and NPD-marketing alignment positively. Environmental munificence is negatively associated with NPD-marketing alignment, but has no effect on the two other forms of alignment. Technological change...... has a positive effect on technological alignment, a negative effect on NPD-marketing alignment, but no effect on market alignment. These findings suggest that internal capabilities are more likely to be associated with the development of strategic alignment than environmental factors are. Furthermore...

  20. Improving the Conservation of Mediterranean Chondrichthyans: The ELASMOMED DNA Barcode Reference Library.

    Directory of Open Access Journals (Sweden)

    Alessia Cariani

    Full Text Available Cartilaginous fish are particularly vulnerable to anthropogenic stressors and environmental change because of their K-selected reproductive strategy. Accurate data from scientific surveys and landings are essential to assess conservation status and to develop robust protection and management plans. Currently available data are often incomplete or incorrect as a result of inaccurate species identifications, due to a high level of morphological stasis, especially among closely related taxa. Moreover, several diagnostic characters clearly visible in adult specimens are less evident in juveniles. Here we present results generated by the ELASMOMED Consortium, a regional network aiming to sample and DNA-barcode the Mediterranean Chondrichthyans with the ultimate goal to provide a comprehensive DNA barcode reference library. This library will support and improve the molecular taxonomy of this group and the effectiveness of management and conservation measures. We successfully barcoded 882 individuals belonging to 42 species (17 sharks, 24 batoids and one chimaera, including four endemic and several threatened ones. Morphological misidentifications were found across most orders, further confirming the need for a comprehensive DNA barcoding library as a valuable tool for the reliable identification of specimens in support of taxonomist who are reviewing current identification keys. Despite low intraspecific variation among their barcode sequences and reduced samples size, five species showed preliminary evidence of phylogeographic structure. Overall, the ELASMOMED initiative further emphasizes the key role accurate DNA barcoding libraries play in establishing reliable diagnostic species specific features in otherwise taxonomically problematic groups for biodiversity management and conservation actions.

  1. DNA methylation–based immune response signature improves patient diagnosis in multiple cancers

    Science.gov (United States)

    Jeschke, Jana; Bizet, Martin; Calonne, Emilie; Dedeurwaerder, Sarah; Garaud, Soizic; Koch, Alexander; Larsimont, Denis; Salgado, Roberto; Van den Eynden, Gert; Willard Gallo, Karen; Defrance, Matthieu; Sotiriou, Christos

    2017-01-01

    BACKGROUND. The tumor immune response is increasingly associated with better clinical outcomes in breast and other cancers. However, the evaluation of tumor-infiltrating lymphocytes (TILs) relies on histopathological measurements with limited accuracy and reproducibility. Here, we profiled DNA methylation markers to identify a methylation of TIL (MeTIL) signature that recapitulates TIL evaluations and their prognostic value for long-term outcomes in breast cancer (BC). METHODS. MeTIL signature scores were correlated with clinical endpoints reflecting overall or disease-free survival and a pathologic complete response to preoperative anthracycline therapy in 3 BC cohorts from the Jules Bordet Institute in Brussels and in other cancer types from The Cancer Genome Atlas. RESULTS. The MeTIL signature measured TIL distributions in a sensitive manner and predicted survival and response to chemotherapy in BC better than did histopathological assessment of TILs or gene expression–based immune markers, respectively. The MeTIL signature also improved the prediction of survival in other malignancies, including melanoma and lung cancer. Furthermore, the MeTIL signature predicted differences in survival for malignancies in which TILs were not known to have a prognostic value. Finally, we showed that MeTIL markers can be determined by bisulfite pyrosequencing of small amounts of DNA from formalin-fixed, paraffin-embedded tumor tissue, supporting clinical applications for this methodology. CONCLUSIONS. This study highlights the power of DNA methylation to evaluate tumor immune responses and the potential of this approach to improve the diagnosis and treatment of breast and other cancers. FUNDING. This work was funded by the Fonds National de la Recherche Scientifique (FNRS) and Télévie, the INNOVIRIS Brussels Region BRUBREAST Project, the IUAP P7/03 program, the Belgian “Foundation against Cancer,” the Breast Cancer Research Foundation (BCRF), and the Fonds Gaston Ithier

  2. Fast pairwise structural RNA alignments by pruning of the dynamical programming matrix

    DEFF Research Database (Denmark)

    Havgaard, Jakob Hull; Torarinsson, Elfar; Gorodkin, Jan

    2007-01-01

    and backtracked in a normal fashion. Finally, the FOLDALIGN algorithm has also been updated with a better memory implementation and an improved energy model. With these improvements in the algorithm, the FOLDALIGN software package provides the molecular biologist with an efficient and user-friendly tool...... the advantage of providing the constraints dynamically. This has been included in a new implementation of the FOLDALIGN algorithm for pairwise local or global structural alignment of RNA sequences. It is shown that time and memory requirements are dramatically lowered while overall performance is maintained....... Furthermore, a new divide and conquer method is introduced to limit the memory requirement during global alignment and backtrack of local alignment. All branch points in the computed RNA structure are found and used to divide the structure into smaller unbranched segments. Each segment is then realigned...

  3. Engineered split in Pfu DNA polymerase fingers domain improves incorporation of nucleotide γ-phosphate derivative

    Science.gov (United States)

    Hansen, Connie J.; Wu, Lydia; Fox, Jeffrey D.; Arezi, Bahram; Hogrefe, Holly H.

    2011-01-01

    Using compartmentalized self-replication (CSR), we evolved a version of Pyrococcus furiosus (Pfu) DNA polymerase that tolerates modification of the γ-phosphate of an incoming nucleotide. A Q484R mutation in α-helix P of the fingers domain, coupled with an unintended translational termination-reinitiation (split) near the finger tip, dramatically improve incorporation of a bulky γ-phosphate-O-linker-dabcyl substituent. Whether synthesized by coupled translation from a bicistronic (−1 frameshift) clone, or reconstituted from separately expressed and purified fragments, split Pfu mutant behaves identically to wild-type DNA polymerase with respect to chromatographic behavior, steady-state kinetic parameters (for dCTP), and PCR performance. Although naturally-occurring splits have been identified previously in the finger tip region of T4 gp43 variants, this is the first time a split (in combination with a point mutation) has been shown to broaden substrate utilization. Moreover, this latest example of a split hyperthermophilic archaeal DNA polymerase further illustrates the modular nature of the Family B DNA polymerase structure. PMID:21062827

  4. Engineered split in Pfu DNA polymerase fingers domain improves incorporation of nucleotide gamma-phosphate derivative.

    Science.gov (United States)

    Hansen, Connie J; Wu, Lydia; Fox, Jeffrey D; Arezi, Bahram; Hogrefe, Holly H

    2011-03-01

    Using compartmentalized self-replication (CSR), we evolved a version of Pyrococcus furiosus (Pfu) DNA polymerase that tolerates modification of the γ-phosphate of an incoming nucleotide. A Q484R mutation in α-helix P of the fingers domain, coupled with an unintended translational termination-reinitiation (split) near the finger tip, dramatically improve incorporation of a bulky γ-phosphate-O-linker-dabcyl substituent. Whether synthesized by coupled translation from a bicistronic (-1 frameshift) clone, or reconstituted from separately expressed and purified fragments, split Pfu mutant behaves identically to wild-type DNA polymerase with respect to chromatographic behavior, steady-state kinetic parameters (for dCTP), and PCR performance. Although naturally-occurring splits have been identified previously in the finger tip region of T4 gp43 variants, this is the first time a split (in combination with a point mutation) has been shown to broaden substrate utilization. Moreover, this latest example of a split hyperthermophilic archaeal DNA polymerase further illustrates the modular nature of the Family B DNA polymerase structure.

  5. Improved chaos-based video steganography using DNA alphabets

    Directory of Open Access Journals (Sweden)

    Nirmalya Kar

    2018-03-01

    Full Text Available DNA based steganography plays a vital role in the field of privacy and secure communication. Here, we propose a DNA properties-based mechanism to send data hidden inside a video file. Initially, the video file is converted into image frames. Random frames are then selected and data is hidden in these at random locations by using the Least Significant Bit substitution method. We analyze the proposed architecture in terms of peak signal-to-noise ratio as well as mean squared error measured between the original and steganographic files averaged over all video frames. The results show minimal degradation of the steganographic video file. Keywords: Chaotic map, DNA, Linear congruential generator, Video steganography, Least significant bit

  6. Precision alignment and calibration of optical systems using computer generated holograms

    Science.gov (United States)

    Coyle, Laura Elizabeth

    As techniques for manufacturing and metrology advance, optical systems are being designed with more complexity than ever before. Given these prescriptions, alignment and calibration can be a limiting factor in their final performance. Computer generated holograms (CGHs) have several unique properties that make them powerful tools for meeting these demanding tolerances. This work will present three novel methods for alignment and calibration of optical systems using computer generated holograms. Alignment methods using CGHs require that the optical wavefront created by the CGH be related to a mechanical datum to locate it space. An overview of existing methods is provided as background, then two new alignment methods are discussed in detail. In the first method, the CGH contact Ball Alignment Tool (CBAT) is used to align a ball or sphere mounted retroreflector (SMR) to a Fresnel zone plate pattern with micron level accuracy. The ball is bonded directly onto the CGH substrate and provides permanent, accurate registration between the optical wavefront and a mechanical reference to locate the CGH in space. A prototype CBAT was built and used to align and bond an SMR to a CGH. In the second method, CGH references are used to align axi-symmetric optics in four degrees of freedom with low uncertainty and real time feedback. The CGHs create simultaneous 3D optical references where the zero order reflection sets tilt and the first diffracted order sets centration. The flexibility of the CGH design can be used to accommodate a wide variety of optical systems and maximize sensitivity to misalignments. A 2-CGH prototype system was aligned multiplied times and the alignment uncertainty was quantified and compared to an error model. Finally, an enhanced calibration method is presented. It uses multiple perturbed measurements of a master sphere to improve the calibration of CGH-based Fizeau interferometers ultimately measuring aspheric test surfaces. The improvement in the

  7. Aligned multi-walled carbon nanotube-reinforced composites: processing and mechanical characterization

    International Nuclear Information System (INIS)

    Thostenson, Erik T.; Chou, Tsuwei

    2002-01-01

    Carbon nanotubes have been the subject of considerable attention because of their exceptional physical and mechanical properties. These properties observed at the nanoscale have motivated researchers to utilize carbon nanotubes as reinforcement in composite materials. In this research, a micro-scale twin-screw extruder was used to achieve dispersion of multi-walled carbon nanotubes in a polystyrene matrix. Highly aligned nanocomposite films were produced by extruding the polymer melt through a rectangular die and drawing the film prior to cooling. Randomly oriented nanocomposites were produced by achieving dispersion first with the twin-screw extruder followed by pressing a film using a hydraulic press. The tensile behaviour of the aligned and random nanocomposite films with 5 wt.{%} loading of nanotubes were characterized. Addition of nanotubes increased the tensile modulus, yield strength and ultimate strengths of the polymer films, and the improvement in elastic modulus with the aligned nanotube composite is five times greater than the improvement for the randomly oriented composite. (author)

  8. Pareto optimal pairwise sequence alignment.

    Science.gov (United States)

    DeRonne, Kevin W; Karypis, George

    2013-01-01

    Sequence alignment using evolutionary profiles is a commonly employed tool when investigating a protein. Many profile-profile scoring functions have been developed for use in such alignments, but there has not yet been a comprehensive study of Pareto optimal pairwise alignments for combining multiple such functions. We show that the problem of generating Pareto optimal pairwise alignments has an optimal substructure property, and develop an efficient algorithm for generating Pareto optimal frontiers of pairwise alignments. All possible sets of two, three, and four profile scoring functions are used from a pool of 11 functions and applied to 588 pairs of proteins in the ce_ref data set. The performance of the best objective combinations on ce_ref is also evaluated on an independent set of 913 protein pairs extracted from the BAliBASE RV11 data set. Our dynamic-programming-based heuristic approach produces approximated Pareto optimal frontiers of pairwise alignments that contain comparable alignments to those on the exact frontier, but on average in less than 1/58th the time in the case of four objectives. Our results show that the Pareto frontiers contain alignments whose quality is better than the alignments obtained by single objectives. However, the task of identifying a single high-quality alignment among those in the Pareto frontier remains challenging.

  9. Generation and application of Bessel beam in alignment works

    International Nuclear Information System (INIS)

    Gale, D. M.

    2009-01-01

    The divergence of a Gaussian laser beam is a limiting factor for optical alignment tasks at large distances. Bessel beams have almost zero divergence but are still not widely used. We discuss the construction of an alignment telescope based on Bessel beam generation using a commercial laser diode module. The Bessel beam is generated with conical or plano-convex lenses, and projected using a commercial CCD camera lens to extend the useful range of the beam. Our Bessel beams have diameters of between 0.5 - 1mm over beam lengths of 15m, representing a six-fold improvement compared to Gaussian beams, while the transverse beam structure (Bessel pattern) provides an excellent alignment aid for use with beam target. Another advantage of Bessel beams is their self-regeneration property, which allows the use of multiple beam targets with minimum beam degradation. We are using our crosshair targets with crosshair targets to align optical components in a large astronomical telescope, and can achieve precisions of tens of microns over distances of 20m using purely visual methods. (Author)

  10. Cells immobilized on patterns printed in DNA by an inkjet printer.

    Science.gov (United States)

    Sakurai, Kengo; Teramura, Yuji; Iwata, Hiroo

    2011-05-01

    The ability to two-dimensionally align various kinds of cells freely onto substrate would be a useful tool for analysis of cell-cell interactions. In this study, we aimed to establish a method for attaching cells to the substrate, in which the pattern is drawn by an inkjet printer. Poly-deoxyribonucleic acid (DNA) was immobilized onto the cell surface by use of DNA-conjugated poly(ethylene) glycol-phospholipid (DNA-PEG-lipid), which is the amphiphilic conjugate of PEG-lipid and single-stranded DNA. The surface of the substrate was then modified with the complementary DNA using an inkjet printer. Finally, DNA-immobilized cells were attached onto the substrate through DNA hybridization. The use of the inkjet printer enabled us to draw the DNA pattern accurately on the substrate with a resolution of a few hundred micrometers. DNA-immobilized cells could be attached precisely along the DNA pattern on the substrate. In addition, various kinds of cells could be attached simultaneously by using various sequences of DNA. Our technique is promising for analysis of cell-cell interactions and differentiation induction in stem cell research. Copyright © 2011 Elsevier Ltd. All rights reserved.

  11. Alignment for CSR

    International Nuclear Information System (INIS)

    Wang Shoujin; Man Kaidi; Guo Yizhen; Cai Guozhu; Guo Yuhui

    2002-01-01

    Cooled Storage Ring of Heavy Ion Research Facility in Lanzhou (HIRFL-CSR) belongs to China great scientific project in China. The alignment for it is very difficult because of very large area and very high accuracy. For the special case in HIRFL-CSR, some new methods and new instruments are used, including the construction of survey control network, the usage of laser tracker, and CSR alignment database system with applications developed to store and analyze data. The author describes the whole procedure of CSR alignment

  12. Experimental conditions improving in-solution target enrichment for ancient DNA

    DEFF Research Database (Denmark)

    Cruz-Dávalos, Diana I.; Llamas, Bastien; Gaunitz, Charleen

    2017-01-01

    High-throughput sequencing has dramatically fostered ancient DNA research in recent years. Shotgun sequencing, however, does not necessarily appear as the best-suited approach due to the extensive contamination of samples with exogenous environmental microbial DNA. DNA capture-enrichment methods ...

  13. Genetic Approaches to Appearance and Ancestry : Improving Forensic DNA Analysis

    NARCIS (Netherlands)

    L.C. Chaitanya (Lakshmi)

    2016-01-01

    textabstractTraditionally, routine forensic casework is based on comparative grounds. DNA profiles obtained from crime-scenes are compared with those of potential suspects or DNA profiles deposited in forensic DNA databases. The principal limitation of such comparative approach is that trace

  14. Pairwise Sequence Alignment Library

    Energy Technology Data Exchange (ETDEWEB)

    2015-05-20

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

  15. Progressive multiple sequence alignments from triplets

    Directory of Open Access Journals (Sweden)

    Stadler Peter F

    2007-07-01

    Full Text Available Abstract Background The quality of progressive sequence alignments strongly depends on the accuracy of the individual pairwise alignment steps since gaps that are introduced at one step cannot be removed at later aggregation steps. Adjacent insertions and deletions necessarily appear in arbitrary order in pairwise alignments and hence form an unavoidable source of errors. Research Here we present a modified variant of progressive sequence alignments that addresses both issues. Instead of pairwise alignments we use exact dynamic programming to align sequence or profile triples. This avoids a large fractions of the ambiguities arising in pairwise alignments. In the subsequent aggregation steps we follow the logic of the Neighbor-Net algorithm, which constructs a phylogenetic network by step-wisely replacing triples by pairs instead of combining pairs to singletons. To this end the three-way alignments are subdivided into two partial alignments, at which stage all-gap columns are naturally removed. This alleviates the "once a gap, always a gap" problem of progressive alignment procedures. Conclusion The three-way Neighbor-Net based alignment program aln3nn is shown to compare favorably on both protein sequences and nucleic acids sequences to other progressive alignment tools. In the latter case one easily can include scoring terms that consider secondary structure features. Overall, the quality of resulting alignments in general exceeds that of clustalw or other multiple alignments tools even though our software does not included heuristics for context dependent (mismatch scores.

  16. Periodontal and restorative considerations with clear aligner treatment to establish a more favorable restorative environment.

    Science.gov (United States)

    Boyd, Robert L

    2009-06-01

    Although standard fixed appliances are better suited to control difficult tooth movement in three planes of space, clear aligner orthodontic treatment may be requested by patients because of the superior esthetics compared with conventional fixed appliances when clear aligners can be considered. Several clinical trials have shown improved periodontal status during orthodontic treatment with clear aligners while fixed appliances have almost always been associated with increased inflammation and mild periodontal breakdown despite preventive measures performed during treatment. There have been no reports of decalcification and only one reported case of root resorption with clear aligners, whereas with fixed appliances, numerous incidents of both decalcification and root resorption have been reported. In addition, studies have also shown significantly less pain from soft-tissue injuries and muscle soreness from parafunctional habits with computer-aided clear aligners. Restorative advantages include improved esthetics and comfort during treatment for better case acceptance and the ability to bleach teeth throughout treatment. Improving tooth alignment with orthodontic treatment with fixed or clear appliances increases the clinician's potential capability to perform more conservative restorative procedures, requiring less tooth structure removal and less endodontic involvement because of better tooth positions. In those cases in which clear aligner appliances may be appropriate, less damage may occur to existing porcelain restorations than might transpire from bonding of fixed appliances and their removal, as well as potentially reduced tooth wear during treatment. This article presents three case reports that demonstrate the periodontal and restorative aspects of treatment using the computer-aided clear appliances, which have either eliminated the need for certain restorative procedures or created a better periodontal and tooth position environment for performing these

  17. Belt Aligning Revisited

    Directory of Open Access Journals (Sweden)

    Yurchenko Vadim

    2017-01-01

    parts of the conveyor, the sides of the belt wear intensively. This results in reducing the life of the belt. The reasons for this phenomenon are well investigated, but the difficulty lies in the fact that they all act simultaneously. The belt misalignment prevention can be carried out in two ways: by minimizing the effect of causes and by aligning the belt. The construction of aligning devices and errors encountered in practice are considered in this paper. Self-aligning roller supports rotational in plan view are recommended as a means of combating the belt misalignment.

  18. Commentary: Organizational Alignment: The Evolution of a Revolution.

    Science.gov (United States)

    Ramias, Alan

    2003-01-01

    Discusses the organizational mindset of human performance technology (HPT) practitioners at the 2001 International Society for Performance Improvement (ISPI) International Conference. Outlines the framework for organizational alignment, the importance for gatekeepers (those who provide access to the company to outsiders; need to development of a…

  19. Antares beam-alignment-system performance

    International Nuclear Information System (INIS)

    Appert, Q.D.; Bender, S.C.

    1983-01-01

    The beam alignment system for the 24-beam-sector Antares CO 2 fusion laser automatically aligns more than 200 optical elements. A visible-wavelength alignment technique is employed which uses a telescope/TV system to view point-light sources appropriately located down the beamline. The centroids of the light spots are determined by a video tracker, which generates error signals used by the computer control system to move appropriate mirrors in a closed-loop system. Final touch-up alignment is accomplished by projecting a CO 2 alignment laser beam through the system and sensing its position at the target location. The techniques and control algorithms employed have resulted in alignment accuracies exceeding design requirements. By employing video processing to determine the centroids of diffraction images and by averaging over multiple TV frames, we achieve alignment accuracies better than 0.1 times system diffraction limits in the presence of air turbulence

  20. Reliability of image-free navigation to monitor lower-limb alignment.

    Science.gov (United States)

    Pearle, Andrew D; Goleski, Patrick; Musahl, Volker; Kendoff, Daniel

    2009-02-01

    Proper alignment of the mechanical axis of the lower limb is the principal goal of a high tibial osteotomy. A well-accepted and relevant technical specification is the coronal plane lower-limb alignment. Target values for coronal plane alignment after high tibial osteotomy include 2 degrees of overcorrection, while tolerances for this specification have been established as 2 degrees to 4 degrees. However, the role of axial plane and sagittal plane realignment after high tibial osteotomy is poorly understood; consequently, targets and tolerance for this technical specification remain undefined. This article reviews the literature concerning the reliability and precision of navigation in monitoring the clinically relevant specification of lower-limb alignment in high tibial osteotomy. We conclude that image-free navigation registration may be clinically useful for intraoperative monitoring of the coronal plane only. Only fair and poor results for the axial and sagittal planes can be obtained by image-free navigation systems. In the future, combined image-based data, such as those from radiographs, magnetic resonance imaging, and gait analysis, may be used to help to improve the accuracy and reproducibility of quantitative intraoperative monitoring of lower-limb alignment.

  1. A UNIFIED MODEL OF GRAIN ALIGNMENT: RADIATIVE ALIGNMENT OF INTERSTELLAR GRAINS WITH MAGNETIC INCLUSIONS

    Energy Technology Data Exchange (ETDEWEB)

    Hoang, Thiem [Canadian Institute for Theoretical Astrophysics, University of Toronto, 60 St. George Street, Toronto, ON M5S 3H8 (Canada); Lazarian, A. [Department of Astronomy, University of Wisconsin-Madison (United States)

    2016-11-10

    The radiative torque (RAT) alignment of interstellar grains with ordinary paramagnetic susceptibilities has been supported by earlier studies. The alignment of such grains depends on the so-called RAT parameter q {sup max}, which is determined by the grain shape. In this paper, we elaborate on our model of RAT alignment for grains with enhanced magnetic susceptibility due to iron inclusions, such that RAT alignment is magnetically enhanced, which we term the MRAT mechanism. Such grains can be aligned with high angular momentum at the so-called high- J attractor points, achieving a high degree of alignment. Using our analytical model of RATs, we derive the critical value of the magnetic relaxation parameter δ {sub m} to produce high- J attractor points as functions of q {sup max} and the anisotropic radiation angle relative to the magnetic field ψ . We find that if about 10% of the total iron abundance present in silicate grains is forming iron clusters, this is sufficient to produce high- J attractor points for all reasonable values of q {sup max}. To calculate the degree of grain alignment, we carry out numerical simulations of MRAT alignment by including stochastic excitations from gas collisions and magnetic fluctuations. We show that large grains can achieve perfect alignment when the high- J attractor point is present, regardless of the values of q {sup max}. Our obtained results pave the way for the physical modeling of polarized thermal dust emission as well as magnetic dipole emission. We also find that millimeter-sized grains in accretion disks may be aligned with the magnetic field if they are incorporated with iron nanoparticles.

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

    CERN Document Server

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

    2003-01-01

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

  3. Sub-cell turning to accomplish micron-level alignment of precision assemblies

    Science.gov (United States)

    Kumler, James J.; Buss, Christian

    2017-08-01

    Higher performance expectations for complex optical systems demand tighter alignment requirements for lens assembly alignment. In order to meet diffraction limited imaging performance over wide spectral bands across the UV and visible wavebands, new manufacturing approaches and tools must be developed if the optical systems will be produced consistently in volume production. This is especially applicable in the field of precision microscope objectives for life science, semiconductor inspection and laser material processing systems. We observe a rising need for the improvement in the optical imaging performance of objective lenses. The key challenge lies in the micron-level decentration and tilt of each lens element. One solution for the production of high quality lens systems is sub-cell assembly with alignment turning. This process relies on an automatic alignment chuck to align the optical axis of a mounted lens to the spindle axis of the machine. Subsequently, the mount is cut with diamond tools on a lathe with respect to the optical axis of the mount. Software controlled integrated measurement technology ensures highest precision. In addition to traditional production processes, further dimensions can be controlled in a very precise manner, e.g. the air gaps between the lenses. Using alignment turning simplifies further alignment steps and reduces the risk of errors. This paper describes new challenges in microscope objective design and manufacturing, and addresses difficulties with standard production processes. A new measurement and alignment technique is described, and strengths and limitations are outlined.

  4. LHCb : Novel real-time alignment and calibration of the LHCb Detector in Run2

    CERN Multimedia

    Tobin, Mark

    2015-01-01

    LHCb has introduced a novel real-time detector alignment and calibration strategy for LHC Run 2. Data collected at the start of the fill will be processed in a few minutes and used to update the alignment, while the calibration constants will be evaluated for each run. This procedure will improve the quality of the online alignment. For example, the vertex locator is retracted and reinserted for stable beam collisions in each fill to be centred on the primary vertex position in the transverse plane. Consequently its position changes on a fill-by-fill basis. Critically, this new realtime alignment and calibration procedure allows identical constants to be used in the online and offline reconstruction, thus improving the correlation between triggered and offline selected events. This offers the opportunity to optimise the event selection in the trigger by applying stronger constraints. The online calibration facilitates the use of hadronic particle identification using the RICH detectors at the trigger level. T...

  5. Polymer chain alignment and transistor properties of nanochannel-templated poly(3-hexylthiophene) nanowires

    Science.gov (United States)

    Oh, Seungjun; Hayakawa, Ryoma; Pan, Chengjun; Sugiyasu, Kazunori; Wakayama, Yutaka

    2016-08-01

    Nanowires of semiconducting poly(3-hexylthiophene) (P3HT) were produced by a nanochannel-template technique. Polymer chain alignment in P3HT nanowires was investigated as a function of nanochannel widths (W) and polymer chain lengths (L). We found that the ratio between chain length and channel width (L/W) was a key parameter as regards promoting polymer chain alignment. Clear dichroism was observed in polarized ultraviolet-visible (UV-Vis) absorption spectra only at a ratio of approximately L/W = 2, indicating that the L/W ratio must be optimized to achieve uniaxial chain alignment in the nanochannel direction. We speculate that an appropriate L/W ratio is effective in confining the geometries and conformations of polymer chains. This discussion was supported by theoretical simulations based on molecular dynamics. That is, the geometry of the polymer chains, including the distance and tilting angles of the chains in relation to the nanochannel surface, was dominant in determining the longitudinal alignment along the nanochannels. Thus prepared highly aligned polymer nanowire is advantageous for electrical carrier transport and has great potential for improving the device performance of field-effect transistors. In fact, a one-order improvement in carrier mobility was observed in a P3HT nanowire transistor.

  6. Statistical assignment of DNA sequences using Bayesian phylogenetics

    DEFF Research Database (Denmark)

    Terkelsen, Kasper Munch; Boomsma, Wouter Krogh; Huelsenbeck, John P.

    2008-01-01

    We provide a new automated statistical method for DNA barcoding based on a Bayesian phylogenetic analysis. The method is based on automated database sequence retrieval, alignment, and phylogenetic analysis using a custom-built program for Bayesian phylogenetic analysis. We show on real data...... that the method outperforms Blast searches as a measure of confidence and can help eliminate 80% of all false assignment based on best Blast hit. However, the most important advance of the method is that it provides statistically meaningful measures of confidence. We apply the method to a re......-analysis of previously published ancient DNA data and show that, with high statistical confidence, most of the published sequences are in fact of Neanderthal origin. However, there are several cases of chimeric sequences that are comprised of a combination of both Neanderthal and modern human DNA....

  7. Roughness and uniformity improvements on self-aligned quadruple patterning technique for 10nm node and beyond by wafer stress engineering

    Science.gov (United States)

    Liu, Eric; Ko, Akiteru; O'Meara, David; Mohanty, Nihar; Franke, Elliott; Pillai, Karthik; Biolsi, Peter

    2017-05-01

    Dimension shrinkage has been a major driving force in the development of integrated circuit processing over a number of decades. The Self-Aligned Quadruple Patterning (SAQP) technique is widely adapted for sub-10nm node in order to achieve the desired feature dimensions. This technique provides theoretical feasibility of multiple pitch-halving from 193nm immersion lithography by using various pattern transferring steps. The major concept of this approach is to a create spacer defined self-aligned pattern by using single lithography print. By repeating the process steps, double, quadruple, or octuple are possible to be achieved theoretically. In these small architectures, line roughness control becomes extremely important since it may contribute to a significant portion of process and device performance variations. In addition, the complexity of SAQP in terms of processing flow makes the roughness improvement indirective and ineffective. It is necessary to discover a new approach in order to improve the roughness in the current SAQP technique. In this presentation, we demonstrate a novel method to improve line roughness performances on 30nm pitch SAQP flow. We discover that the line roughness performance is strongly related to stress management. By selecting different stress level of film to be deposited onto the substrate, we can manipulate the roughness performance in line and space patterns. In addition, the impact of curvature change by applied film stress to SAQP line roughness performance is also studied. No significant correlation is found between wafer curvature and line roughness performance. We will discuss in details the step-by-step physical performances for each processing step in terms of critical dimension (CD)/ critical dimension uniformity (CDU)/line width roughness (LWR)/line edge roughness (LER). Finally, we summarize the process needed to reach the full wafer performance targets of LWR/LER in 1.07nm/1.13nm on 30nm pitch line and space pattern.

  8. Studies on in situ magnetic alignment of bonded anisotropic Nd-Fe-B alloy powders

    Energy Technology Data Exchange (ETDEWEB)

    Nlebedim, I.C. [Ames Laboratory, Ames, IA 50011 (United States); Ucar, Huseyin; Hatter, Christine B. [Oak Ridge National Laboratory, Oak Ridge, TN 37831 (United States); McCallum, R.W. [Ames Laboratory, Ames, IA 50011 (United States); McCall, Scott K. [Lawrence Livermore National Laboratory, Livermore, CA 94550 (United States); Kramer, M.J. [Ames Laboratory, Ames, IA 50011 (United States); Paranthaman, M. Parans [Oak Ridge National Laboratory, Oak Ridge, TN 37831 (United States)

    2017-01-15

    Considerations for achieving high degree of alignment in polymer bonded permanent magnets are presented via the results of a study on in situ magnetic alignment of anisotropic Nd-Fe-B magnet powders. Contributions from effect of the alignment temperature, alignment magnetic field and the properties of the polymer on the hard magnetic properties of the bonded magnet were considered. The thermo-rheological properties of the polymer and the response of the magnet powders to the applied magnetic field indicate that hard magnetic properties were optimized at an alignment temperature just above the melting temperature of the EVA co-polymer. This agrees with an observed correlation between the change in magnetization due to improved magnetic alignment of the anisotropic powders and the change in viscosity of the binder. Manufacturing cost can be minimized by identifying optimum alignment temperatures and magnetic field strengths. - Highlights: • Optimum alignment of anisotropic magnet powders can enable high performance bonded magnets. • The viscoelastic state of polymer binders determines the dominating coercivity mechanism. • The minimum deviation in coercivity and remanence, with magnetic field, can occur at different temperatures. • Melting characteristics of polymer binders and the change in magnetization during alignment can be correlated.

  9. Studies on in situ magnetic alignment of bonded anisotropic Nd-Fe-B alloy powders

    International Nuclear Information System (INIS)

    Nlebedim, I.C.; Ucar, Huseyin; Hatter, Christine B.; McCallum, R.W.; McCall, Scott K.; Kramer, M.J.; Paranthaman, M. Parans

    2017-01-01

    Considerations for achieving high degree of alignment in polymer bonded permanent magnets are presented via the results of a study on in situ magnetic alignment of anisotropic Nd-Fe-B magnet powders. Contributions from effect of the alignment temperature, alignment magnetic field and the properties of the polymer on the hard magnetic properties of the bonded magnet were considered. The thermo-rheological properties of the polymer and the response of the magnet powders to the applied magnetic field indicate that hard magnetic properties were optimized at an alignment temperature just above the melting temperature of the EVA co-polymer. This agrees with an observed correlation between the change in magnetization due to improved magnetic alignment of the anisotropic powders and the change in viscosity of the binder. Manufacturing cost can be minimized by identifying optimum alignment temperatures and magnetic field strengths. - Highlights: • Optimum alignment of anisotropic magnet powders can enable high performance bonded magnets. • The viscoelastic state of polymer binders determines the dominating coercivity mechanism. • The minimum deviation in coercivity and remanence, with magnetic field, can occur at different temperatures. • Melting characteristics of polymer binders and the change in magnetization during alignment can be correlated.

  10. Galaxy Alignments: Theory, Modelling & Simulations

    Science.gov (United States)

    Kiessling, Alina; Cacciato, Marcello; Joachimi, Benjamin; Kirk, Donnacha; Kitching, Thomas D.; Leonard, Adrienne; Mandelbaum, Rachel; Schäfer, Björn Malte; Sifón, Cristóbal; Brown, Michael L.; Rassat, Anais

    2015-11-01

    The shapes of galaxies are not randomly oriented on the sky. During the galaxy formation and evolution process, environment has a strong influence, as tidal gravitational fields in the large-scale structure tend to align nearby galaxies. Additionally, events such as galaxy mergers affect the relative alignments of both the shapes and angular momenta of galaxies throughout their history. These "intrinsic galaxy alignments" are known to exist, but are still poorly understood. This review will offer a pedagogical introduction to the current theories that describe intrinsic galaxy alignments, including the apparent difference in intrinsic alignment between early- and late-type galaxies and the latest efforts to model them analytically. It will then describe the ongoing efforts to simulate intrinsic alignments using both N-body and hydrodynamic simulations. Due to the relative youth of this field, there is still much to be done to understand intrinsic galaxy alignments and this review summarises the current state of the field, providing a solid basis for future work.

  11. MUON DETECTORS: ALIGNMENT

    CERN Multimedia

    G.Gomez

    Since September, the muon alignment system shifted from a mode of hardware installation and commissioning to operation and data taking. All three optical subsystems (Barrel, Endcap and Link alignment) have recorded data before, during and after CRAFT, at different magnetic fields and during ramps of the magnet. This first data taking experience has several interesting goals: •    study detector deformations and movements under the influence of the huge magnetic forces; •    study the stability of detector structures and of the alignment system over long periods, •    study geometry reproducibility at equal fields (specially at 0T and 3.8T); •    reconstruct B=0T geometry and compare to nominal/survey geometries; •    reconstruct B=3.8T geometry and provide DT and CSC alignment records for CMSSW. However, the main goal is to recons...

  12. Improved AMOLED with aligned poly-Si thin-film transistors by laser annealing and chemical solution treatments

    International Nuclear Information System (INIS)

    Wu, G.M.; Chen, C.N.; Feng, W.S.; Lu, H.C.

    2009-01-01

    Low-temperature polycrystalline silicon (LTPS) thin-film transistors (TFT) were prepared for the active-matrix organic light-emitting displays (AMOLED). The excimer laser annealing (ELA) recrystallization technique was employed with a chemical solution treatment process to improve the TFT characteristic uniformity and the AMOLED display image quality. The characteristics of the poly-Si array thin films were influenced by XeCl ELA optic module design, TFT device channel direction, and laser irradiation overlap ratio. The ELA system module provided aligned poly-Si grain size of 0.3 μm by the homogenization lens design. The chemical solution treatment process included a dilute HF solution (DHF), ozone (O 3 ) water, and buffer oxide etching solution (BOE). The PMOS TFT showed better field effect mobility of 87.6 cm 2 /V s, and the threshold voltage was -1.35 V. The off current (I off ) was 1.25x10 -11 A, and the on/off current ratio was 6.27x10 6 . In addition, the image quality of the AMOLED display was highly improved using the 2T1C structure design without any compensation circuit.

  13. The Greatest Learning Return on Your Pedagogical Investment: Alignment, Assessment or In-Class Instruction?

    Science.gov (United States)

    Holt, Emily A; Young, Craig; Keetch, Jared; Larsen, Skylar; Mollner, Brayden

    2015-01-01

    Critical thinking is often considered an essential learning outcome of institutions in higher education. Previous work has proposed three pedagogical strategies to address this goal: more active, student-centered in-class instruction, assessments which contain higher-order cognitive questions, and greater alignment within a classroom (i.e., high agreement of the cognitive level of learning objectives, assessments, and in-class instruction). Our goals were to determine which of these factors, individually or the interactions therein, contributed most to improvements in university students' critical thinking. We assessed students' higher-order cognitive skills in introductory non-majors biology courses the first and last week of instruction. For each of the fifteen sections observed, we also measured the cognitive level of assessments and learning objectives, evaluated the learner-centeredness of each classroom, and calculated an alignment score for each class. The best model to explain improvements in students' high-order cognitive skills contained the measure of learner-centeredness of the class and pre-quiz scores as a covariate. The cognitive level of assessments, learning objectives, nor alignment explained improvements in students' critical thinking. In accordance with much of the current literature, our findings support that more student-centered classes had greater improvements in student learning. However, more research is needed to clarify the role of assessment and alignment in student learning.

  14. The Greatest Learning Return on Your Pedagogical Investment: Alignment, Assessment or In-Class Instruction?

    Directory of Open Access Journals (Sweden)

    Emily A Holt

    Full Text Available Critical thinking is often considered an essential learning outcome of institutions in higher education. Previous work has proposed three pedagogical strategies to address this goal: more active, student-centered in-class instruction, assessments which contain higher-order cognitive questions, and greater alignment within a classroom (i.e., high agreement of the cognitive level of learning objectives, assessments, and in-class instruction. Our goals were to determine which of these factors, individually or the interactions therein, contributed most to improvements in university students' critical thinking. We assessed students' higher-order cognitive skills in introductory non-majors biology courses the first and last week of instruction. For each of the fifteen sections observed, we also measured the cognitive level of assessments and learning objectives, evaluated the learner-centeredness of each classroom, and calculated an alignment score for each class. The best model to explain improvements in students' high-order cognitive skills contained the measure of learner-centeredness of the class and pre-quiz scores as a covariate. The cognitive level of assessments, learning objectives, nor alignment explained improvements in students' critical thinking. In accordance with much of the current literature, our findings support that more student-centered classes had greater improvements in student learning. However, more research is needed to clarify the role of assessment and alignment in student learning.

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

    Science.gov (United States)

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

    2018-05-03

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

  16. On-site detection of Phytophthora spp.—single-stranded target DNA as the limiting factor to improve on-chip hybridization

    International Nuclear Information System (INIS)

    Schwenkbier, Lydia; Pollok, Sibyll; Popp, Jürgen; Weber, Karina; König, Stephan; Wagner, Stefan; Werres, Sabine; Weber, Jörg; Hentschel, Martin

    2014-01-01

    We report on a lab-on-a-chip approach for on-site detection of Phytophthora species that allows visual signal readout. The results demonstrate the significance of single-stranded DNA (ssDNA) generation in terms of improving the intensity of the hybridization signal and to improve the reliability of the method. Conventional PCR with subsequent heat denaturation, sodium hydroxide-based denaturation, lambda exonuclease digestion and two asymmetric PCR methods were investigated for the species P. fragariae, P. kernoviae, and P. ramorum. The positioning of the capture probe within the amplified yeast GTP-binding protein (YPT1) target DNA was also of interest because it significantly influences the intensity of the signal. Statistical tests were used to validate the impact of the ssDNA generation methods and the capture-target probe position. The single-stranded target DNA generated by Linear-After-The-Exponential PCR (LATE-PCR) was found to produce signal intensities comparable to post-PCR exonuclease treatment. The LATE-PCR is the best method for the on-site detection of Phytophthora because the enzymatic digestion after PCR is more laborious and time-consuming. (author)

  17. Nova laser alignment control system

    International Nuclear Information System (INIS)

    Van Arsdall, P.J.; Holloway, F.W.; McGuigan, D.L.; Shelton, R.T.

    1984-01-01

    Alignment of the Nova laser requires control of hundreds of optical components in the ten beam paths. Extensive application of computer technology makes daily alignment practical. The control system is designed in a manner which provides both centralized and local manual operator controls integrated with automatic closed loop alignment. Menudriven operator consoles using high resolution color graphics displays overlaid with transport touch panels allow laser personnel to interact efficiently with the computer system. Automatic alignment is accomplished by using image analysis techniques to determine beam references points from video images acquired along the laser chain. A major goal of the design is to contribute substantially to rapid experimental turnaround and consistent alignment results. This paper describes the computer-based control structure and the software methods developed for aligning this large laser system

  18. Alignment of the drift tube detector at the neutrino oscillation experiment OPERA

    International Nuclear Information System (INIS)

    Goellnitz, Christoph

    2012-09-01

    The present thesis was composed during the course of the OPERA experiment, which aims to give a direct evidence for neutrino oscillations in the channel ν μ → ν τ . The OPERA detector is designed to observe the appearance of tau neutrinos in an originally pure muon neutrino beam, the CNGS beam. As important part of the detector the precision tracker (PT), a drift tube detector, consists of 9504 drift tubes in 198 modules. In this thesis, several parts of the slow control of the PT are developed and implemented to ensure operation during data taking over several years. The main part is the geometric calibration, the alignment of the detector. The alignment procedure contains both hardware and software parts, the software methods are developed and applied. Using straight particle tracks, the detector components are geometrically corrected. A special challenge for the alignment for the PT is the fact that at this kind of low-rate experiment only a small number of particle tracks is available. With software-based corrections of the module rotation, a systematic error of 0.2 mrad has been attained, for corrections of translation, a systematic error of 32 μm is reached. For the alignment between two adjacent PT walls, the statistical error is less than 8 μm. All results of the position monitoring system are considered. All developed methods are tested with Monte Carlo simulations. The detector requirements (Δp/p ≤ 0.25 below 25 GeV) are met. The analysis of the momentum measurement for high energies above 25 GeV demonstrates the resulting improvement. The mean momentum is falling significantly using the new alignment values. The significance of the detector alignment becomes most evident in the analysis of cosmic particles. The muon charge ratio R μ is expected not to be angular dependent. The χ 2 probability of the measured distribution improves up to 58%. The muon charge ratio was also investigated in dependence of particle energy in terms of the alignment

  19. A recoding method to improve the humoral immune response to an HIV DNA vaccine.

    Directory of Open Access Journals (Sweden)

    Yaoxing Huang

    Full Text Available This manuscript describes a novel strategy to improve HIV DNA vaccine design. Employing a new information theory based bioinformatic algorithm, we identify a set of nucleotide motifs which are common in the coding region of HIV, but are under-represented in genes that are highly expressed in the human genome. We hypothesize that these motifs contribute to the poor protein expression of gag, pol, and env genes from the c-DNAs of HIV clinical isolates. Using this approach and beginning with a codon optimized consensus gag gene, we recode the nucleotide sequence so as to remove these motifs without modifying the amino acid sequence. Transfecting the recoded DNA sequence into a human kidney cell line results in doubling the gag protein expression level compared to the codon optimized version. We then turn both sequences into DNA vaccines and compare induced antibody response in a murine model. Our sequence, which has the motifs removed, induces a five-fold increase in gag antibody response compared to the codon optimized vaccine.

  20. Improved molecular detection of Babesia infections in animals using a novel quantitative real-time PCR diagnostic assay targeting mitochondrial DNA.

    Science.gov (United States)

    Qurollo, Barbara A; Archer, Nikole R; Schreeg, Megan E; Marr, Henry S; Birkenheuer, Adam J; Haney, Kaitlin N; Thomas, Brittany S; Breitschwerdt, Edward B

    2017-03-07

    Babesiosis is a protozoal, tick transmitted disease found worldwide in humans, wildlife and domesticated animals. Commonly used approaches to diagnose babesiosis include microscopic examination of peripheral blood smears, detection of circulating antibodies and PCR. To screen and differentiate canine Babesia infections many PCR assays amplify the 18S rRNA gene. These sequences contain hypervariable regions flanked by highly conserved regions allowing for amplification of a broad-range of Babesia spp. However, differences in the 18S rRNA gene sequence of distantly related clades can make it difficult to design assays that will amplify all Babesia species while excluding the amplification of other eukaryotes. By targeting Babesia mitochondrial genome (mtDNA), we designed a novel three primer qPCR with greater sensitivity and broader screening capabilities to diagnose and differentiate Babesia spp. Using 13 Babesia mtDNA sequences, a region spanning two large subunit rRNA gene fragments (lsu5-lsu4) was aligned to design three primers for use in a qPCR assay (LSU qPCR) capable of amplifying a wide range of Babesia spp. Plasmid clones were generated and used as standards to determine efficiency, linear dynamic range and analytical sensitivity. Animals naturally infected with vector-borne pathogens were tested retrospectively and prospectively to determine relative clinical sensitivity and specificity by comparing the LSU qPCR to an established 18S rDNA qPCR. The LSU qPCR efficiencies ranged between 92 and 100% with the limit of detection at five copies/reaction. The assay did not amplify mammalian host or other vector-borne pathogen gDNA except Cytauxzoon felis (a feline protozoal pathogen). The LSU qPCR assay amplified 12 different Babesia. sp. and C. felis from 31/31 (100%) archived samples, whereas the 18S qPCR amplified only 26/31 (83.9%). By prospective analysis, 19/394 diagnostic accessions (4.8%) were LSU qPCR positive, compared to 11/394 (2.8%) 18S rDNA q

  1. Electrical conduction in 7 nm wires constructed on λ-DNA

    International Nuclear Information System (INIS)

    Lund, John; Dong Jianchun; Deng Zhaoxiang; Mao Chengde; Parviz, Babak A

    2006-01-01

    We examine the morphological and electrical characteristics of nanowires fabricated on DNA templates via palladium (Pd) reduction. λ-DNA molecules were stretched and aligned on a mica surface using a molecular combing technique, followed by an electroless deposition of palladium, resulting in formation of nanowires with nominal width of 7 nm. We investigated the size distribution of nanowires with atomic force microscopy and made electrical connections to the wires by metal evaporation through multiple shadow masks. Electrical characterization of the nanowires under various bias conditions, variable temperature, and with different contact metal work functions revealed a conduction mechanism resembling that of granular metals

  2. Photothermal Transport of DNA in Entropy-Landscape Plasmonic Waveguides

    DEFF Research Database (Denmark)

    Smith, Cameron; Thilsted, Anil Haraksingh; Pedersen, Jonas Nyvold

    2017-01-01

    landscapes. Separately, a range of plasmonic configurations have demonstrated active manipulation of nano-objects by harnessing concentrated electric fields. The integration of these two independent techniques promises a range of sophisticated and complementary functions to handle, for example, DNA...... photothermal transport of DNA through the losses of plasmonic modes. The propulsive forces, assisted by in-coupling to propagating channel plasmon polaritons, extend along the V-grooves with a directed motion up to ≈0.5 μm·mW-1 away from the input beam and λ-DNA velocities reaching ≈0.2 μm·s-1·mW-1....... The entropic trapping enables the V-grooves to be flexibly loaded and unloaded with DNA by variation of transverse fluid flow, a process that is selective to biopolymers versus fixed-shape objects and also allows the technique to address the challenges of nanoscale interaction volumes. Our self-aligning, light...

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

    Science.gov (United States)

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

    2018-01-01

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

  4. HBLAST: Parallelised sequence similarity--A Hadoop MapReducable basic local alignment search tool.

    Science.gov (United States)

    O'Driscoll, Aisling; Belogrudov, Vladislav; Carroll, John; Kropp, Kai; Walsh, Paul; Ghazal, Peter; Sleator, Roy D

    2015-04-01

    The recent exponential growth of genomic databases has resulted in the common task of sequence alignment becoming one of the major bottlenecks in the field of computational biology. It is typical for these large datasets and complex computations to require cost prohibitive High Performance Computing (HPC) to function. As such, parallelised solutions have been proposed but many exhibit scalability limitations and are incapable of effectively processing "Big Data" - the name attributed to datasets that are extremely large, complex and require rapid processing. The Hadoop framework, comprised of distributed storage and a parallelised programming framework known as MapReduce, is specifically designed to work with such datasets but it is not trivial to efficiently redesign and implement bioinformatics algorithms according to this paradigm. The parallelisation strategy of "divide and conquer" for alignment algorithms can be applied to both data sets and input query sequences. However, scalability is still an issue due to memory constraints or large databases, with very large database segmentation leading to additional performance decline. Herein, we present Hadoop Blast (HBlast), a parallelised BLAST algorithm that proposes a flexible method to partition both databases and input query sequences using "virtual partitioning". HBlast presents improved scalability over existing solutions and well balanced computational work load while keeping database segmentation and recompilation to a minimum. Enhanced BLAST search performance on cheap memory constrained hardware has significant implications for in field clinical diagnostic testing; enabling faster and more accurate identification of pathogenic DNA in human blood or tissue samples. Copyright © 2015 Elsevier Inc. All rights reserved.

  5. Improved method for extraction and detection of Helicobacter pylori DNA in formalin-fixed paraffin embedded gastric biopsies using laser micro-dissection.

    Science.gov (United States)

    Loayza, María Fernanda; Villavicencio, Fernando Xavier; Santander, Stephanie Carolina; Baldeón, Manuel; Ponce, Lourdes Karina; Salvador, Iván; Vivar Díaz, Nicolás

    2015-01-01

    To assess the molecular events exerted by Helicobacter pylori interacting directly with gastric epithelial cells, an improved procedure for microbial DNA isolation from stained hematoxilin-eosin gastric biopsies was developed based on laser micro-dissection (LM) [1]. Few articles have described the use of LM to select and detect H. pylori genome from formalin-fixed paraffin embedded gastric tissue [2]. To improve the yield and quality of DNA isolated from H. pylori contacting intestinal epithelial cells, the following conditions were established after modification of the QIAamp DNA Micro kit. •Use of at least 25 cut sections of 10-20 μm of diameter and 3 μm thick with more than 10 bacteria in each cut.•Lysis with 30 μL of tissue lysis buffer and 20 μL of proteinase K (PK) with the tube in an upside-down position.•The use of thin purification columns with 35 μL of elution buffer. The mean of DNA concentration obtained from 25 LM cut sections was 1.94± 0 .16 ng/μL, and it was efficiently amplified with qPCR in a Bio Rad iCycler instrument. The LM can improve the sample selection and DNA extraction for molecular analysis of H. pylori associated with human gastric epithelium.

  6. R3D Align web server for global nucleotide to nucleotide alignments of RNA 3D structures.

    Science.gov (United States)

    Rahrig, Ryan R; Petrov, Anton I; Leontis, Neocles B; Zirbel, Craig L

    2013-07-01

    The R3D Align web server provides online access to 'RNA 3D Align' (R3D Align), a method for producing accurate nucleotide-level structural alignments of RNA 3D structures. The web server provides a streamlined and intuitive interface, input data validation and output that is more extensive and easier to read and interpret than related servers. The R3D Align web server offers a unique Gallery of Featured Alignments, providing immediate access to pre-computed alignments of large RNA 3D structures, including all ribosomal RNAs, as well as guidance on effective use of the server and interpretation of the output. By accessing the non-redundant lists of RNA 3D structures provided by the Bowling Green State University RNA group, R3D Align connects users to structure files in the same equivalence class and the best-modeled representative structure from each group. The R3D Align web server is freely accessible at http://rna.bgsu.edu/r3dalign/.

  7. Homeotropic alignment and Förster resonance energy transfer: The way to a brighter luminescent solar concentrator

    Energy Technology Data Exchange (ETDEWEB)

    Tummeltshammer, Clemens; Taylor, Alaric; Kenyon, Anthony J.; Papakonstantinou, Ioannis, E-mail: i.papakonstantinou@ucl.ac.uk [Department of Electronic and Electrical Engineering, University College London, London WC1E 7JE (United Kingdom)

    2014-11-07

    We investigate homeotropically aligned fluorophores and Förster resonance energy transfer (FRET) for luminescent solar concentrators using Monte-Carlo ray tracing. The homeotropic alignment strongly improves the trapping efficiency, while FRET circumvents the low absorption at homeotropic alignment by separating the absorption and emission processes. We predict that this design doped with two organic dye molecules can yield a 82.9% optical efficiency improvement compared to a single, arbitrarily oriented dye molecule. We also show that quantum dots are prime candidates for absorption/donor fluorophores due to their wide absorption band. The potentially strong re-absorption and low quantum yield of quantum dots is not a hindrance for this design.

  8. Aligned Layers of Silver Nano-Fibers

    Directory of Open Access Journals (Sweden)

    Andrii B. Golovin

    2012-02-01

    Full Text Available We describe a new dichroic polarizers made by ordering silver nano-fibers to aligned layers. The aligned layers consist of nano-fibers and self-assembled molecular aggregates of lyotropic liquid crystals. Unidirectional alignment of the layers is achieved by means of mechanical shearing. Aligned layers of silver nano-fibers are partially transparent to a linearly polarized electromagnetic radiation. The unidirectional alignment and density of the silver nano-fibers determine degree of polarization of transmitted light. The aligned layers of silver nano-fibers might be used in optics, microwave applications, and organic electronics.

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

    Directory of Open Access Journals (Sweden)

    Dan Tufis

    2006-05-01

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

  10. Enhancing ionic conductivity in composite polymer electrolytes with well-aligned ceramic nanowires

    Science.gov (United States)

    Liu, Wei; Lee, Seok Woo; Lin, Dingchang; Shi, Feifei; Wang, Shuang; Sendek, Austin D.; Cui, Yi

    2017-04-01

    In contrast to conventional organic liquid electrolytes that have leakage, flammability and chemical stability issues, solid electrolytes are widely considered as a promising candidate for the development of next-generation safe lithium-ion batteries. In solid polymer electrolytes that contain polymers and lithium salts, inorganic nanoparticles are often used as fillers to improve electrochemical performance, structure stability, and mechanical strength. However, such composite polymer electrolytes generally have low ionic conductivity. Here we report that a composite polymer electrolyte with well-aligned inorganic Li+-conductive nanowires exhibits an ionic conductivity of 6.05 × 10-5 S cm-1 at 30 ∘C, which is one order of magnitude higher than previous polymer electrolytes with randomly aligned nanowires. The large conductivity enhancement is ascribed to a fast ion-conducting pathway without crossing junctions on the surfaces of the aligned nanowires. Moreover, the long-term structural stability of the polymer electrolyte is also improved by the use of nanowires.

  11. Context dependent DNA evolutionary models

    DEFF Research Database (Denmark)

    Jensen, Jens Ledet

    This paper is about stochastic models for the evolution of DNA. For a set of aligned DNA sequences, connected in a phylogenetic tree, the models should be able to explain - in probabilistic terms - the differences seen in the sequences. From the estimates of the parameters in the model one can...... start to make biologically interpretations and conclusions concerning the evolutionary forces at work. In parallel with the increase in computing power, models have become more complex. Starting with Markov processes on a space with 4 states, and extended to Markov processes with 64 states, we are today...... studying models on spaces with 4n (or 64n) number of states with n well above one hundred, say. For such models it is no longer possible to calculate the transition probability analytically, and often Markov chain Monte Carlo is used in connection with likelihood analysis. This is also the approach taken...

  12. Joint Processing of Envelope Alignment and Phase Compensation for Isar Imaging

    Science.gov (United States)

    Chen, Tao; Jin, Guanghu; Dong, Zhen

    2018-04-01

    Range envelope alignment and phase compensation are spilt into two isolated parts in the classical methods of translational motion compensation in Inverse Synthetic Aperture Radar (ISAR) imaging. In classic method of the rotating object imaging, the two reference points of the envelope alignment and the Phase Difference (PD) estimation are probably not the same point, making it difficult to uncouple the coupling term by conducting the correction of Migration Through Resolution Cell (MTRC). In this paper, an improved approach of joint processing which chooses certain scattering point as the sole reference point is proposed to perform with utilizing the Prominent Point Processing (PPP) method. With this end in view, we firstly get the initial image using classical methods from which a certain scattering point can be chose. The envelope alignment and phase compensation using the selected scattering point as the same reference point are subsequently conducted. The keystone transform is thus smoothly applied to further improve imaging quality. Both simulation experiments and real data processing are provided to demonstrate the performance of the proposed method compared with classical method.

  13. Alignment of CEBAF cryomodules

    International Nuclear Information System (INIS)

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

    1993-06-01

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

  14. Conjugation of Benzylvanillin and Benzimidazole Structure Improves DNA Binding with Enhanced Antileukemic Properties

    Science.gov (United States)

    Al-Mudarris, Ban A.; Chen, Shih-Hsun; Liang, Po-Huang; Osman, Hasnah; Jamal Din, Shah Kamal Khan; Abdul Majid, Amin M. S.

    2013-01-01

    Benzyl-o-vanillin and benzimidazole nucleus serve as important pharmacophore in drug discovery. The benzyl vanillin (2-(benzyloxy)-3-methoxybenzaldehyde) compound shows anti-proliferative activity in HL60 leukemia cancer cells and can effect cell cycle progression at G2/M phase. Its apoptosis activity was due to disruption of mitochondrial functioning. In this study, we have studied a series of compounds consisting of benzyl vanillin and benzimidazole structures. We hypothesize that by fusing these two structures we can produce compounds that have better anticancer activity with improved specificity particularly towards the leukemia cell line. Here we explored the anticancer activity of three compounds namely 2-(2-benzyloxy-3-methoxyphenyl)-1H-benzimidazole, 2MP, N-1-(2-benzyloxy-3-methoxybenzyl)-2-(2-benzyloxy-3-methoxyphenyl)-1H-benzimidazole, 2XP, and (R) and (S)-1-(2-benzyloxy-3-methoxyphenyl)-2, 2, 2-trichloroethyl benzenesulfonate, 3BS and compared their activity to 2-benzyloxy-3-methoxybenzaldehyde, (Bn1), the parent compound. 2XP and 3BS induces cell death of U937 leukemic cell line through DNA fragmentation that lead to the intrinsic caspase 9 activation. DNA binding study primarily by the equilibrium binding titration assay followed by the Viscosity study reveal the DNA binding through groove region with intrinsic binding constant 7.39 µM/bp and 6.86 µM/bp for 3BS and 2XP respectively. 2XP and 3BS showed strong DNA binding activity by the UV titration method with the computational drug modeling showed that both 2XP and 3BS failed to form any electrostatic linkages except via hydrophobic interaction through the minor groove region of the nucleic acid. The benzylvanillin alone (Bn1) has weak anticancer activity even after it was combined with the benzimidazole (2MP), but after addition of another benzylvanillin structure (2XP), stronger activity was observed. Also, the combination of benzylvanillin with benzenesulfonate (3BS) significantly improved the

  15. Oral antioxidant treatment partly improves integrity of human sperm DNA in infertile grade I varicocele patients.

    Science.gov (United States)

    Gual-Frau, Josep; Abad, Carlos; Amengual, María J; Hannaoui, Naim; Checa, Miguel A; Ribas-Maynou, Jordi; Lozano, Iris; Nikolaou, Alexandros; Benet, Jordi; García-Peiró, Agustín; Prats, Juan

    2015-09-01

    Infertile males with varicocele have the highest percentage of sperm cells with damaged DNA, compared to other infertile groups. Antioxidant treatment is known to enhance the integrity of sperm DNA; however, there are no data on the effects in varicocele patients. We thus investigated the potential benefits of antioxidant treatment specifically in grade I varicocele males. Twenty infertile patients with grade I varicocele were given multivitamins (1500 mg L-Carnitine, 60 mg vitamin C, 20 mg coenzyme Q10, 10 mg vitamin E, 200 μg vitamin B9, 1 μg vitamin B12, 10 mg zinc, 50 μg selenium) daily for three months. Semen parameters including total sperm count, concentration, progressive motility, vitality, and morphology were determined before and after treatment. In addition, sperm DNA fragmentation and the amount of highly degraded sperm cells were analyzed by Sperm Chromatin Dispersion. After treatment, patients showed an average relative reduction of 22.1% in sperm DNA fragmentation (p = 0.02) and had 31.3% fewer highly degraded sperm cells (p = 0.07). Total numbers of sperm cells were increased (p = 0.04), but other semen parameters were unaffected. These data suggest that sperm DNA integrity in grade I varicocele patients may be improved by oral antioxidant treatment.

  16. Physician-Hospital Alignment in Orthopedic Surgery.

    Science.gov (United States)

    Bushnell, Brandon D

    2015-09-01

    The concept of "alignment" between physicians and hospitals is a popular buzzword in the age of health care reform. Despite their often tumultuous histories, physicians and hospitals find themselves under increasing pressures to work together toward common goals. However, effective alignment is more than just simple cooperation between parties. The process of achieving alignment does not have simple, universal steps. Alignment will differ based on individual situational factors and the type of specialty involved. Ultimately, however, there are principles that underlie the concept of alignment and should be a part of any physician-hospital alignment efforts. In orthopedic surgery, alignment involves the clinical, administrative, financial, and even personal aspects of a surgeon's practice. It must be based on the principles of financial interest, clinical authority, administrative participation, transparency, focus on the patient, and mutual necessity. Alignment can take on various forms as well, with popular models consisting of shared governance and comanagement, gainsharing, bundled payments, accountable care organizations, and other methods. As regulatory and financial pressures continue to motivate physicians and hospitals to develop alignment relationships, new and innovative methods of alignment will also appear. Existing models will mature and evolve, with individual variability based on local factors. However, certain trends seem to be appearing as time progresses and alignment relationships deepen, including regional and national collaboration, population management, and changes in the legal system. This article explores the history, principles, and specific methods of physician-hospital alignment and its critical importance for the future of health care delivery. Copyright 2015, SLACK Incorporated.

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

    CERN Document Server

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

    2016-01-01

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

  18. Organizational Alignment Supporting Distance Education in Post-Secondary Institutions.

    Science.gov (United States)

    Prestera, Gustavo E.; Moller, Leslie A.

    2001-01-01

    Applies an established model of organizational alignment to distance education in postsecondary institutions and recommends performance-oriented approaches to support growth by analyzing goals, structure, and management practices across the organization. Presents performance improvement strategies such as benchmarking and documenting workflows,…

  19. Colour stabilities of three types of orthodontic clear aligners exposed to staining agents.

    Science.gov (United States)

    Liu, Chen-Lu; Sun, Wen-Tian; Liao, Wen; Lu, Wen-Xin; Li, Qi-Wen; Jeong, Yunho; Liu, Jun; Zhao, Zhi-He

    2016-12-16

    The aim of this study was to evaluate and compare the colour stabilities of three types of orthodontic clear aligners exposed to staining agents in vitro. Sixty clear orthodontic aligners produced by three manufacturers (Invisalign, Angelalign, and Smartee) were immersed in three staining solutions (coffee, black tea, and red wine) and one control solution (distilled water). After 12-h and 7-day immersions, the aligners were washed in an ultrasonic cleaner and measured with a colourimeter. The colour changes (ΔE*) were calculated on the basis of the Commission Internationale de I'Eclairage L*a*b* colour system (CIE L*a*b*), and the results were then converted into National Bureau of Standards (NBS) units. Fourier transformation infrared (FT-IR) spectroscopy and scanning electron microscopy (SEM) were conducted to observe the molecular and morphologic alterations to the aligner surfaces, respectively. The three types of aligners exhibited slight colour changes after 12 h of staining, with the exception of the Invisalign aligners stained with coffee. The Invisalign aligners exhibited significantly higher ΔE* values (ranging from 0.30 to 27.81) than those of the Angelalign and Smartee aligners (ΔE* values ranging from 0.33 to 1.89 and 0.32 to 1.61, respectively, Paligners did not exhibit significant chemical differences before and after the immersions. The SEM results revealed different surface alterations to the three types of aligner materials after the 7-day staining. The three types of aesthetic orthodontic appliances exhibited colour stability after the 12-h immersion, with the exception of the Invisalign aligners stained by coffee. The Invisalign aligners were more prone than the Angelalign and Smartee aligners to pigmentation. Aligner materials may be improved by considering aesthetic colour stability properties.

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

    Science.gov (United States)

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

    2012-07-15

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

  1. Georgia science curriculum alignment and accountability: A blueprint for student success

    Science.gov (United States)

    Reining-Gray, Kimberly M.

    Current trends and legislation in education indicate an increased dependency on standardized test results as a measure for learner success. This study analyzed test data in an effort to assess the impact of curriculum alignment on learner success as well as teacher perceptions of the changes in classroom instruction due to curriculum alignment. Qualitative and quantitative design methods were used to determine the impact of science curriculum alignment in grades 9-12. To determine the impact of science curriculum alignment from the Quality Core Curriculum (QCC) to the Georgia Performance Standards (GPS) test data and teacher opinion surveys from one Georgia School system were examined. Standardized test scores before and after curriculum alignment were analyzed as well as teacher perception survey data regarding the impact of curriculum change. A quantitative teacher perception survey was administered to science teachers in the school system to identify significant changes in teacher perceptions or teaching strategies following curriculum realignment. Responses to the survey were assigned Likert scale values for analysis purposes. Selected teachers were also interviewed using panel-approved questions to further determine teacher opinions of curriculum realignment and the impact on student success and teaching strategies. Results of this study indicate significant changes related to curriculum alignment. Teachers reported a positive change in teaching strategies and instructional delivery as a result of curriculum alignment and implementation. Student scores also showed improvement, but more research is recommended in this area.

  2. The CMS Silicon Tracker Alignment

    CERN Document Server

    Castello, R

    2008-01-01

    The alignment of the Strip and Pixel Tracker of the Compact Muon Solenoid experiment, with its large number of independent silicon sensors and its excellent spatial resolution, is a complex and challenging task. Besides high precision mounting, survey measurements and the Laser Alignment System, track-based alignment is needed to reach the envisaged precision.\\\\ Three different algorithms for track-based alignment were successfully tested on a sample of cosmic-ray data collected at the Tracker Integration Facility, where 15\\% of the Tracker was tested. These results, together with those coming from the CMS global run, will provide the basis for the full-scale alignment of the Tracker, which will be carried out with the first \\emph{p-p} collisions.

  3. Improved Methods of Carnivore Faecal Sample Preservation, DNA Extraction and Quantification for Accurate Genotyping of Wild Tigers

    Science.gov (United States)

    Harika, Katakam; Mahla, Ranjeet Singh; Shivaji, Sisinthy

    2012-01-01

    Background Non-invasively collected samples allow a variety of genetic studies on endangered and elusive species. However due to low amplification success and high genotyping error rates fewer samples can be identified up to the individual level. Number of PCRs needed to obtain reliable genotypes also noticeably increase. Methods We developed a quantitative PCR assay to measure and grade amplifiable nuclear DNA in feline faecal extracts. We determined DNA degradation in experimentally aged faecal samples and tested a suite of pre-PCR protocols to considerably improve DNA retrieval. Results Average DNA concentrations of Grade I, II and III extracts were 982pg/µl, 9.5pg/µl and 0.4pg/µl respectively. Nearly 10% of extracts had no amplifiable DNA. Microsatellite PCR success and allelic dropout rates were 92% and 1.5% in Grade I, 79% and 5% in Grade II, and 54% and 16% in Grade III respectively. Our results on experimentally aged faecal samples showed that ageing has a significant effect on quantity and quality of amplifiable DNA (pDNA degradation occurs within 3 days of exposure to direct sunlight. DNA concentrations of Day 1 samples stored by ethanol and silica methods for a month varied significantly from fresh Day 1 extracts (p0.05). DNA concentrations of fresh tiger and leopard faecal extracts without addition of carrier RNA were 816.5pg/µl (±115.5) and 690.1pg/µl (±207.1), while concentrations with addition of carrier RNA were 49414.5pg/µl (±9370.6) and 20982.7pg/µl (±6835.8) respectively. Conclusions Our results indicate that carnivore faecal samples should be collected as freshly as possible, are better preserved by two-step method and should be extracted with addition of carrier RNA. We recommend quantification of template DNA as this facilitates several downstream protocols. PMID:23071624

  4. Measuring Parameters of Massive Black Hole Binaries with Partially Aligned Spins

    Science.gov (United States)

    Lang, Ryan N.; Hughes, Scott A.; Cornish, Neil J.

    2011-01-01

    The future space-based gravitational wave detector LISA will be able to measure parameters of coalescing massive black hole binaries, often to extremely high accuracy. Previous work has demonstrated that the black hole spins can have a strong impact on the accuracy of parameter measurement. Relativistic spin-induced precession modulates the waveform in a manner which can break degeneracies between parameters, in principle significantly improving how well they are measured. Recent studies have indicated, however, that spin precession may be weak for an important subset of astrophysical binary black holes: those in which the spins are aligned due to interactions with gas. In this paper, we examine how well a binary's parameters can be measured when its spins are partially aligned and compare results using waveforms that include higher post-Newtonian harmonics to those that are truncated at leading quadrupole order. We find that the weakened precession can substantially degrade parameter estimation, particularly for the "extrinsic" parameters sky position and distance. Absent higher harmonics, LISA typically localizes the sky position of a nearly aligned binary about an order of magnitude less accurately than one for which the spin orientations are random. Our knowledge of a source's sky position will thus be worst for the gas-rich systems which are most likely to produce electromagnetic counterparts. Fortunately, higher harmonics of the waveform can make up for this degradation. By including harmonics beyond the quadrupole in our waveform model, we find that the accuracy with which most of the binary's parameters are measured can be substantially improved. In some cases, the improvement is such that they are measured almost as well as when the binary spins are randomly aligned.

  5. Unified Alignment of Protein-Protein Interaction Networks.

    Science.gov (United States)

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

    2017-04-19

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

  6. Utility of T-DNA insertion mutagenesis in arabidopsis for crop improvement

    Energy Technology Data Exchange (ETDEWEB)

    Feldmann, K A [Arizona Univ., Tucson, AZ (United States). Dept. of Plant Sciences

    1995-11-01

    T-DNA insertion mutagenesis in Arabidopsis is an efficient and expedient method for isolating genes that may have agronomic importance in crop plants. More than 14,000 transformants, with an average of 1.5 inserts per transformant, have been generated in the laboratory at the University of Arizona, Tucson, United States of America. Assuming that the genome of Arabidopsis is 100 Mb and that insertion is random, there is a greater than 50% probability that any particular gene has been tagged in this population. These transformed lines have been screened for any visible alteration in phenotype. In addition, they have been screened under numerous selective regimes such as cold tolerance, auxin and ethylene resistance or sensitivity, and nitrate utilization, among many others. Twenty per cent of these transformants segregate for some type of mutation. Approximately 40% of these are due to T-DNA insertion. Genes have already been cloned from various developmental and biochemical pathways, including flower, root and trichome morphology, light and ethylene regulated growth, fatty acid desaturation and epicuticular wax (EW) production. Some of the isolated genes are being introduced into agronomic species in an attempt to improve specific traits. For example, two genes important in EW production have been introduced into Brassica oleracea (broccoli) to modify the nature of the EW such that engineered plants will show greater resistance to herbivorous insects. Similarly, genes involved in fatty acid desaturation, male sterility, height or nitrogen metabolism, to mention only a few, could also be utilized to improve certain crop traits via genetic engineering. Several of these examples are described. (author). 57 refs, 1 fig., 2 tabs.

  7. Precision alignment device

    Science.gov (United States)

    Jones, N.E.

    1988-03-10

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

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

    CERN Document Server

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

    2012-01-01

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

  9. Curricular Alignment: A Re-examination.

    Science.gov (United States)

    Anderson, Lorin W.

    2002-01-01

    Examines key differences among content coverage, opportunity to learn, and curriculum alignment, suggesting that the revised Taxonomy provides a framework for analyzing curriculum alignment and illustrating how the Taxonomy Table can be used to estimate curriculum alignment. The paper notes that the revised Taxonomy enables educators to probe…

  10. Consistent Alignment of World Embedding Models

    Science.gov (United States)

    2017-03-02

    propose a solution that aligns variations of the same model (or different models) in a joint low-dimensional la- tent space leveraging carefully...representations of linguistic enti- ties, most often referred to as embeddings. This includes techniques that rely on matrix factoriza- tion (Levy & Goldberg ...higher, the variation is much higher as well. As we increase the size of the neighborhood, or improve the quality of our sample by only picking the most

  11. ALIGNING THE BRAND IDENTITY AND BRAND IMAGE AFTER REBRANDING

    Directory of Open Access Journals (Sweden)

    Cătălin Mihail BARBU

    2016-11-01

    Full Text Available The brand identity and brand image are two concepts used extensively in positioning. Many brands underwent a rebranding process attempting to improve their positioning. The rebranding process can bring minor changes or substantial changes. Following the substantial changes, there can appear a mismatch between the desired identity and brand image. Brand image is persistent and it takes time to change it. This paper explores the challenges involved by the calibration of the identity and of the image in the process of rebranding. The alignment process is a dynamic one, an interactive and not a normative one. The results of this study highlight the elements that support the brand identity and image alignment: marketing communication, product characteristics and internal brand strength. On the other side, the efforts to align the brand identity and brand image are negatively affected by the attitudes of the consumers and their past experience with the brand.

  12. In silico engineering and optimization of Transcription Activator-Like Effectors and their derivatives for improved DNA binding predictions.

    KAUST Repository

    Piatek, Marek J.

    2015-12-01

    Transcription Activator-Like Effectors (TALEs) can be used as adaptable DNAbinding modules to create site-specific chimeric nucleases or synthetic transcriptional regulators. The central repeat domain mediates specific DNA binding via hypervariable repeat di-residues (RVDs). This DNA-Binding Domain can be engineered to bind preferentially to any user-selected DNA sequence if engineered appropriately. Therefore, TALEs and their derivatives have become indispensable molecular tools in site-specific manipulation of genes and genomes. This thesis revolves around two problems: in silico design and improved binding site prediction of TALEs. In the first part, a study is shown where TALEs are successfully designed in silico and validated in laboratory to yield the anticipated effects on selected genes. Software is developed to accompany the process of designing and prediction of binding sites. I expanded the functionality of the software to be used as a more generic set of tools for the design, target and offtarget searching. Part two contributes a method and associated toolkit developed to allow users to design in silico optimized synthetic TALEs with user-defined specificities for various experimental purposes. This method is based on a mutual relationship of three consecutive tandem repeats in the DNA-binding domain. This approach revealed positional and compositional bias behind the binding of TALEs to DNA. In conclusion, I developed methods, approaches, and software to enhance the functionality of synthetic TALEs, which should improve understanding of TALEs biology and will further advance genome-engineering applications in various organisms and cell types.

  13. Effect of mat pilates exercise on postural alignment and body composition of middle-aged women.

    Science.gov (United States)

    Lee, Hyo Taek; Oh, Hyun Ok; Han, Hui Seung; Jin, Kwang Youn; Roh, Hyo Lyun

    2016-06-01

    [Purpose] This study attempted to examine whether Pilates is an effective exercise for improving the postural alignment and health of middle-aged women. [Subjects and Methods] The participants in this study were 36 middle-aged women (20 in the experimental group, 16 in the control group). The experimental group participated in Pilates exercise sessions three times a week for 12 weeks. Body alignment and composition measurements before and after applying the Pilates exercise program were performed with a body composition analyzer and a three-dimensional scanner. [Results] Postural alignment in the sagittal and horizontal planes was enhanced in the Pilates exercise group. Trunk alignment showed correlations with body fat and muscle mass. [Conclusion] The Pilates exercises are performed symmetrically and strengthen the deep muscles. Moreover, the results showed that muscle mass was correlated with trunk postural alignment and that the proper amount of muscle is critical in maintaining trunk postural alignment.

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

  15. Geodetic alignment of laser power installations

    International Nuclear Information System (INIS)

    Shtorm, V.V.; Gostev, A.M.; Drobikov, A.V.

    1989-01-01

    Main problems occuring in applied geodesy under initial alignment of laser power installation optical channel are considered. Attention is paid to alignment of lens beamguide telescopic pairs and alignment quality control. Methods and means of geodetic measurements under alignment are indicated. Conclusions are made about the degree of working through certain aspects of the problem

  16. Acid or erythromycin stress significantly improves transformation efficiency through regulating expression of DNA binding proteins in Lactococcus lactis F44.

    Science.gov (United States)

    Wang, Binbin; Zhang, Huawei; Liang, Dongmei; Hao, Panlong; Li, Yanni; Qiao, Jianjun

    2017-12-01

    Lactococcus lactis is a gram-positive bacterium used extensively in the dairy industry and food fermentation, and its biological characteristics are usually improved through genetic manipulation. However, poor transformation efficiency was the main restriction factor for the construction of engineered strains. In this study, the transformation efficiency of L. lactis F44 showed a 56.1-fold increase in acid condition (pH 5.0); meanwhile, erythromycin stress (0.04 μg/mL) promoted the transformation efficiency more significantly (76.9-fold). Notably, the transformation efficiency of F44e (L. lactis F44 harboring empty pLEB124) increased up to 149.1-fold under the synergistic stresses of acid and erythromycin. In addition, the gene expression of some DNA binding proteins (DprA, RadA, RadC, RecA, RecQ, and SsbA) changed correspondingly. Especially for radA, 25.1-fold improvement was detected when F44e was exposed to pH 5.0. Overexpression of some DNA binding proteins could improve the transformation efficiency. The results suggested that acid or erythromycin stress could improve the transformation efficiency of L. lactis through regulating gene expression of DNA binding proteins. We have proposed a simple but promising strategy for improving the transformation efficiency of L. lactis and other hard-transformed microorganisms. Copyright © 2017 American Dairy Science Association. Published by Elsevier Inc. All rights reserved.

  17. Production and characterization of polymer nanocomposite with aligned single wall carbon nanotubes

    International Nuclear Information System (INIS)

    Chen Wei; Tao Xiaoming

    2006-01-01

    We reported a simple method to fabricate polymer nanocomposites with single-walled carbon nanotubes (SWNTs) having exceptional alignment and improved mechanical properties. The composite films were fabricated by casting a suspension of single walled carbon nanotubes in a solution of thermoplastic polyurethane and tetrahydrofuran. The orientation as well as dispersion of nanotubes was determined by scanning electron microscopy, transmission electron microscopy and polarized Raman spectroscopy. The macroscopic alignment probably results from solvent-polymer interaction induced orientation of soft segment chain during swelling and moisture curing. The tensile behavior of the aligned nanotube composite film was also studied. At a 0.5 wt.% nanotube loading, a 1.9-fold increase in Young's modulus was achieved

  18. Aligning Metabolic Pathways Exploiting Binary Relation of Reactions.

    Directory of Open Access Journals (Sweden)

    Yiran Huang

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

  19. AlignNemo: a local network alignment method to integrate homology and topology.

    Directory of Open Access Journals (Sweden)

    Giovanni Ciriello

    Full Text Available Local network alignment is an important component of the analysis of protein-protein interaction networks that may lead to the identification of evolutionary related complexes. We present AlignNemo, a new algorithm that, given the networks of two organisms, uncovers subnetworks of proteins that relate in biological function and topology of interactions. The discovered conserved subnetworks have a general topology and need not to correspond to specific interaction patterns, so that they more closely fit the models of functional complexes proposed in the literature. The algorithm is able to handle sparse interaction data with an expansion process that at each step explores the local topology of the networks beyond the proteins directly interacting with the current solution. To assess the performance of AlignNemo, we ran a series of benchmarks using statistical measures as well as biological knowledge. Based on reference datasets of protein complexes, AlignNemo shows better performance than other methods in terms of both precision and recall. We show our solutions to be biologically sound using the concept of semantic similarity applied to Gene Ontology vocabularies. The binaries of AlignNemo and supplementary details about the algorithms and the experiments are available at: sourceforge.net/p/alignnemo.

  20. FMIT alignment cart

    International Nuclear Information System (INIS)

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

    1981-01-01

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

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

    Energy Technology Data Exchange (ETDEWEB)

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

    2014-08-04

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

  2. Alignment method for parabolic trough solar concentrators

    Science.gov (United States)

    Diver, Richard B [Albuquerque, NM

    2010-02-23

    A Theoretical Overlay Photographic (TOP) alignment method uses the overlay of a theoretical projected image of a perfectly aligned concentrator on a photographic image of the concentrator to align the mirror facets of a parabolic trough solar concentrator. The alignment method is practical and straightforward, and inherently aligns the mirror facets to the receiver. When integrated with clinometer measurements for which gravity and mechanical drag effects have been accounted for and which are made in a manner and location consistent with the alignment method, all of the mirrors on a common drive can be aligned and optimized for any concentrator orientation.

  3. Only marginal alignment of disc galaxies

    Science.gov (United States)

    Andrae, René; Jahnke, Knud

    2011-12-01

    Testing theories of angular-momentum acquisition of rotationally supported disc galaxies is the key to understanding the formation of this type of galaxies. The tidal-torque theory aims to explain this acquisition process in a cosmological framework and predicts positive autocorrelations of angular-momentum orientation and spiral-arm handedness, i.e. alignment of disc galaxies, on short distance scales of 1 Mpc h-1. This disc alignment can also cause systematic effects in weak-lensing measurements. Previous observations claimed discovering these correlations but are overly optimistic in the reported level of statistical significance of the detections. Errors in redshift, ellipticity and morphological classifications were not taken into account, although they have a significant impact. We explain how to rigorously propagate all the important errors through the estimation process. Analysing disc galaxies in the Sloan Digital Sky Survey (SDSS) data base, we find that positive autocorrelations of spiral-arm handedness and angular-momentum orientations on distance scales of 1 Mpc h-1 are plausible but not statistically significant. Current data appear not good enough to constrain parameters of theory. This result agrees with a simple hypothesis test in the Local Group, where we also find no evidence for disc alignment. Moreover, we demonstrate that ellipticity estimates based on second moments are strongly biased by galactic bulges even for Scd galaxies, thereby corrupting correlation estimates and overestimating the impact of disc alignment on weak-lensing studies. Finally, we discuss the potential of future sky surveys. We argue that photometric redshifts have too large errors, i.e. PanSTARRS and LSST cannot be used. Conversely, the EUCLID project will not cover the relevant redshift regime. We also discuss the potentials and problems of front-edge classifications of galaxy discs in order to improve the autocorrelation estimates of angular-momentum orientation.

  4. Novel real-time alignment and calibration of the LHCb detector in Run2

    CERN Document Server

    AUTHOR|(INSPIRE)INSPIRE-00144085

    2017-01-01

    LHCb has introduced a novel real-time detector alignment and calibration strategy for LHC Run2. Data collected at the start of the fill are processed in a few minutes and used to update the alignment parameters, while the calibration constants are evaluated for each run. This procedure improves the quality of the online reconstruction. For example, the vertex locator is retracted and reinserted for stable beam conditions in each fill to be centred on the primary vertex position in the transverse plane. Consequently its position changes on a fill-by-fill basis. Critically, this new real-time alignment and calibration procedure allows identical constants to be used in the online and offline reconstruction, thus improving the correlation between triggered and offline-selected events. This offers the opportunity to optimise the event selection in the trigger by applying stronger constraints. The required computing time constraints are met thanks to a new dedicated framework using the multi-core farm infrastructur...

  5. A high-throughput and quantitative method to assess the mutagenic potential of translesion DNA synthesis

    Science.gov (United States)

    Taggart, David J.; Camerlengo, Terry L.; Harrison, Jason K.; Sherrer, Shanen M.; Kshetry, Ajay K.; Taylor, John-Stephen; Huang, Kun; Suo, Zucai

    2013-01-01

    Cellular genomes are constantly damaged by endogenous and exogenous agents that covalently and structurally modify DNA to produce DNA lesions. Although most lesions are mended by various DNA repair pathways in vivo, a significant number of damage sites persist during genomic replication. Our understanding of the mutagenic outcomes derived from these unrepaired DNA lesions has been hindered by the low throughput of existing sequencing methods. Therefore, we have developed a cost-effective high-throughput short oligonucleotide sequencing assay that uses next-generation DNA sequencing technology for the assessment of the mutagenic profiles of translesion DNA synthesis catalyzed by any error-prone DNA polymerase. The vast amount of sequencing data produced were aligned and quantified by using our novel software. As an example, the high-throughput short oligonucleotide sequencing assay was used to analyze the types and frequencies of mutations upstream, downstream and at a site-specifically placed cis–syn thymidine–thymidine dimer generated individually by three lesion-bypass human Y-family DNA polymerases. PMID:23470999

  6. NN-align. An artificial neural network-based alignment algorithm for MHC class II peptide binding prediction

    Directory of Open Access Journals (Sweden)

    Lund Ole

    2009-09-01

    Full Text Available Abstract Background The major histocompatibility complex (MHC molecule plays a central role in controlling the adaptive immune response to infections. MHC class I molecules present peptides derived from intracellular proteins to cytotoxic T cells, whereas MHC class II molecules stimulate cellular and humoral immunity through presentation of extracellularly derived peptides to helper T cells. Identification of which peptides will bind a given MHC molecule is thus of great importance for the understanding of host-pathogen interactions, and large efforts have been placed in developing algorithms capable of predicting this binding event. Results Here, we present a novel artificial neural network-based method, NN-align that allows for simultaneous identification of the MHC class II binding core and binding affinity. NN-align is trained using a novel training algorithm that allows for correction of bias in the training data due to redundant binding core representation. Incorporation of information about the residues flanking the peptide-binding core is shown to significantly improve the prediction accuracy. The method is evaluated on a large-scale benchmark consisting of six independent data sets covering 14 human MHC class II alleles, and is demonstrated to outperform other state-of-the-art MHC class II prediction methods. Conclusion The NN-align method is competitive with the state-of-the-art MHC class II peptide binding prediction algorithms. The method is publicly available at http://www.cbs.dtu.dk/services/NetMHCII-2.0.

  7. Probabilistic biological network alignment.

    Science.gov (United States)

    Todor, Andrei; Dobra, Alin; Kahveci, Tamer

    2013-01-01

    Interactions between molecules are probabilistic events. An interaction may or may not happen with some probability, depending on a variety of factors such as the size, abundance, or proximity of the interacting molecules. In this paper, we consider the problem of aligning two biological networks. Unlike existing methods, we allow one of the two networks to contain probabilistic interactions. Allowing interaction probabilities makes the alignment more biologically relevant at the expense of explosive growth in the number of alternative topologies that may arise from different subsets of interactions that take place. We develop a novel method that efficiently and precisely characterizes this massive search space. We represent the topological similarity between pairs of aligned molecules (i.e., proteins) with the help of random variables and compute their expected values. We validate our method showing that, without sacrificing the running time performance, it can produce novel alignments. Our results also demonstrate that our method identifies biologically meaningful mappings under a comprehensive set of criteria used in the literature as well as the statistical coherence measure that we developed to analyze the statistical significance of the similarity of the functions of the aligned protein pairs.

  8. Agarose electrophoresis of DNA in discontinuous buffers, using a horizontal slab apparatus and a buffer system with improved properties.

    Science.gov (United States)

    Zsolnai, A; Orbán, L; Chrambach, A

    1993-03-01

    Using a horizontal slab apparatus with a buffer in the reservoirs at the level of the gel ("sea-level electrophoresis"), the retrograde discontinuous buffer system reported by Wiltfang et al. for sodium dodecyl sulfate-polyacrylamide gel electrophoresis (SDS-PAGE) of proteins was applied to DNA electrophoresis. This application yielded the advantages of an increased displacement rate of the moving boundary front and a decrease in the concentration of the counterion base in the resolving phase, which yielded reduced relative mobility values at equivalent gel concentrations and practicable low buffer concentrations. The change of relative mobilities (Rf) with a variation of field strength is decreased compared to that of the migration rate in the continuous Tris-boric-acid-EDTA (TBE) buffer and thus the robustness of the system is improved, as well as the efficiency of separation. The system of Wiltfang et al. has in common with previously described discontinuous DNA system, that it is able to stack DNA from dilute samples and is insensitive to sample components with lower net mobilities than DNA, such as acetate. However, the variance of Rf at constant current density in the discontinuous buffer system is not improved over that of the migration rate at constant field strength in the continuous TBE buffer.

  9. Alignment of the CMS Muon System with Cosmic-Ray and Beam-Halo Muons

    CERN Document Server

    Chatrchyan, S; Sirunyan, A M; Adam, W; Arnold, B; Bergauer, H; Bergauer, T; Dragicevic, M; Eichberger, M; Erö, J; Friedl, M; Frühwirth, R; Ghete, V M; Hammer, J; Hänsel, S; Hoch, M; Hörmann, N; Hrubec, J; Jeitler, M; Kasieczka, G; Kastner, K; Krammer, M; Liko, D; Magrans de Abril, I; Mikulec, I; Mittermayr, F; Neuherz, B; Oberegger, M; Padrta, M; Pernicka, M; Rohringer, H; Schmid, S; Schöfbeck, R; Schreiner, T; Stark, R; Steininger, H; Strauss, J; Taurok, A; Teischinger, F; Themel, T; Uhl, D; Wagner, P; Waltenberger, W; Walzel, G; Widl, E; Wulz, C E; Chekhovsky, V; Dvornikov, O; Emeliantchik, I; Litomin, A; Makarenko, V; Marfin, I; Mossolov, V; Shumeiko, N; Solin, A; Stefanovitch, R; Suarez Gonzalez, J; Tikhonov, A; Fedorov, A; Karneyeu, A; Korzhik, M; Panov, V; Zuyeuski, R; Kuchinsky, P; Beaumont, W; Benucci, L; Cardaci, M; De Wolf, E A; Delmeire, E; Druzhkin, D; Hashemi, M; Janssen, X; Maes, T; Mucibello, L; Ochesanu, S; Rougny, R; Selvaggi, M; Van Haevermaet, H; Van Mechelen, P; Van Remortel, N; Adler, V; Beauceron, S; Blyweert, S; D'Hondt, J; De Weirdt, S; Devroede, O; Heyninck, J; Kalogeropoulos, A; Maes, J; Maes, M; Mozer, M U; Tavernier, S; Van Doninck, W; Van Mulders, P; Villella, I; Bouhali, O; Chabert, E C; Charaf, O; Clerbaux, B; De Lentdecker, G; Dero, V; Elgammal, S; Gay, A P R; Hammad, G H; Marage, P E; Rugovac, S; Vander Velde, C; Vanlaer, P; Wickens, J; Grunewald, M; Klein, B; Marinov, A; Ryckbosch, D; Thyssen, F; Tytgat, M; Vanelderen, L; Verwilligen, P; Basegmez, S; Bruno, G; Caudron, J; Delaere, C; Demin, P; Favart, D; Giammanco, A; Grégoire, G; Lemaitre, V; Militaru, O; Ovyn, S; Piotrzkowski, K; Quertenmont, L; Schul, N; Beliy, N; Daubie, E; Alves, G A; Pol, M E; Souza, M H G; Carvalho, W; De Jesus Damiao, D; De Oliveira Martins, C; Fonseca De Souza, S; Mundim, L; Oguri, V; Santoro, A; Silva Do Amaral, S M; Sznajder, A; Fernandez Perez Tomei, T R; Ferreira Dias, M A; Gregores, E M; Novaes, S F; Abadjiev, K; Anguelov, T; Damgov, J; Darmenov, N; Dimitrov, L; Genchev, V; Iaydjiev, P; Piperov, S; Stoykova, S; Sultanov, G; Trayanov, R; Vankov, I; Dimitrov, A; Dyulendarova, M; Kozhuharov, V; Litov, L; Marinova, E; Mateev, M; Pavlov, B; Petkov, P; Toteva, Z; Chen, G M; Chen, H S; Guan, W; Jiang, C H; Liang, D; Liu, B; Meng, X; Tao, J; Wang, J; Wang, Z; Xue, Z; Zhang, Z; Ban, Y; Cai, J; Ge, Y; Guo, S; Hu, Z; Mao, Y; Qian, S J; Teng, H; Zhu, B; Avila, C; Baquero Ruiz, M; Carrillo Montoya, C A; Gomez, A; Gomez Moreno, B; Ocampo Rios, A A; Osorio Oliveros, A F; Reyes Romero, D; Sanabria, J C; Godinovic, N; Lelas, K; Plestina, R; Polic, D; Puljak, I; Antunovic, Z; Dzelalija, M; Brigljevic, V; Duric, S; Kadija, K; Morovic, S; Fereos, R; Galanti, M; Mousa, J; Papadakis, A; Ptochos, F; Razis, P A; Tsiakkouri, D; Zinonos, Z; Hektor, A; Kadastik, M; Kannike, K; Müntel, M; Raidal, M; Rebane, L; Anttila, E; Czellar, S; Härkönen, J; Heikkinen, A; Karimäki, V; Kinnunen, R; Klem, J; Kortelainen, M J; Lampén, T; Lassila-Perini, K; Lehti, S; Lindén, T; Luukka, P; Mäenpää, T; Nysten, J; Tuominen, E; Tuominiemi, J; Ungaro, D; Wendland, L; Banzuzi, K; Korpela, A; Tuuva, T; Nedelec, P; Sillou, D; Besancon, M; Chipaux, R; Dejardin, M; Denegri, D; Descamps, J; Fabbro, B; Faure, J L; Ferri, F; Ganjour, S; Gentit, F X; Givernaud, A; Gras, P; Hamel de Monchenault, G; Jarry, P; Lemaire, M C; Locci, E; Malcles, J; Marionneau, M; Millischer, L; Rander, J; Rosowsky, A; Rousseau, D; Titov, M; Verrecchia, P; Baffioni, S; Bianchini, L; Bluj, M; Busson, P; Charlot, C; Dobrzynski, L; Granier de Cassagnac, R; Haguenauer, M; Miné, P; Paganini, P; Sirois, Y; Thiebaux, C; Zabi, A; Agram, J L; Besson, A; Bloch, D; Bodin, D; Brom, J M; Conte, E; Drouhin, F; Fontaine, J C; Gelé, D; Goerlach, U; Gross, L; Juillot, P; Le Bihan, A C; Patois, Y; Speck, J; Van Hove, P; Baty, C; Bedjidian, M; Blaha, J; Boudoul, G; Brun, H; Chanon, N; Chierici, R; Contardo, D; Depasse, P; Dupasquier, T; El Mamouni, H; Fassi, F; Fay, J; Gascon, S; Ille, B; Kurca, T; Le Grand, T; Lethuillier, M; Lumb, N; Mirabito, L; Perries, S; Vander Donckt, M; Verdier, P; Djaoshvili, N; Roinishvili, N; Roinishvili, V; Amaglobeli, N; Adolphi, R; Anagnostou, G; Brauer, R; Braunschweig, W; Edelhoff, M; Esser, H; Feld, L; Karpinski, W; Khomich, A; Klein, K; Mohr, N; Ostaptchouk, A; Pandoulas, D; Pierschel, G; Raupach, F; Schael, S; Schultz von Dratzig, A; Schwering, G; Sprenger, D; Thomas, M; Weber, M; Wittmer, B; Wlochal, M; Actis, O; Altenhöfer, G; Bender, W; Biallass, P; Erdmann, M; Fetchenhauer, G; Frangenheim, J; Hebbeker, T; Hilgers, G; Hinzmann, A; Hoepfner, K; Hof, C; Kirsch, M; Klimkovich, T; Kreuzer, P; Lanske, D; Merschmeyer, M; Meyer, A; Philipps, B; Pieta, H; Reithler, H; Schmitz, S A; Sonnenschein, L; Sowa, M; Steggemann, J; Szczesny, H; Teyssier, D; Zeidler, C; Bontenackels, M; Davids, M; Duda, M; Flügge, G; Geenen, H; Giffels, M; Haj Ahmad, W; Hermanns, T; Heydhausen, D; Kalinin, S; Kress, T; Linn, A; Nowack, A; Perchalla, L; Poettgens, M; Pooth, O; Sauerland, P; Stahl, A; Tornier, D; Zoeller, M H; Aldaya Martin, M; Behrens, U; Borras, K; Campbell, A; Castro, E; Dammann, D; Eckerlin, G; Flossdorf, A; Flucke, G; Geiser, A; Hatton, D; Hauk, J; Jung, H; Kasemann, M; Katkov, I; Kleinwort, C; Kluge, H; Knutsson, A; Kuznetsova, E; Lange, W; Lohmann, W; Mankel, R; Marienfeld, M; Meyer, A B; Miglioranzi, S; Mnich, J; Ohlerich, M; Olzem, J; Parenti, A; Rosemann, C; Schmidt, R; Schoerner-Sadenius, T; Volyanskyy, D; Wissing, C; Zeuner, W D; Autermann, C; Bechtel, F; Draeger, J; Eckstein, D; Gebbert, U; Kaschube, K; Kaussen, G; Klanner, R; Mura, B; Naumann-Emme, S; Nowak, F; Pein, U; Sander, C; Schleper, P; Schum, T; Stadie, H; Steinbrück, G; Thomsen, J; Wolf, R; Bauer, J; Blüm, P; Buege, V; Cakir, A; Chwalek, T; De Boer, W; Dierlamm, A; Dirkes, G; Feindt, M; Felzmann, U; Frey, M; Furgeri, A; Gruschke, J; Hackstein, C; Hartmann, F; Heier, S; Heinrich, M; Held, H; Hirschbuehl, D; Hoffmann, K H; Honc, S; Jung, C; Kuhr, T; Liamsuwan, T; Martschei, D; Mueller, S; Müller, Th; Neuland, M B; Niegel, M; Oberst, O; Oehler, A; Ott, J; Peiffer, T; Piparo, D; Quast, G; Rabbertz, K; Ratnikov, F; Ratnikova, N; Renz, M; Saout, C; Sartisohn, G; Scheurer, A; Schieferdecker, P; Schilling, F P; Schott, G; Simonis, H J; Stober, F M; Sturm, P; Troendle, D; Trunov, A; Wagner, W; Wagner-Kuhr, J; Zeise, M; Zhukov, V; Ziebarth, E B; Daskalakis, G; Geralis, T; Karafasoulis, K; Kyriakis, A; Loukas, D; Markou, A; Markou, C; Mavrommatis, C; Petrakou, E; Zachariadou, A; Gouskos, L; Katsas, P; Panagiotou, A; Evangelou, I; Kokkas, P; Manthos, N; Papadopoulos, I; Patras, V; Triantis, F A; Bencze, G; Boldizsar, L; Debreczeni, G; Hajdu, C; Hernath, S; Hidas, P; Horvath, D; Krajczar, K; Laszlo, A; Patay, G; Sikler, F; Toth, N; Vesztergombi, G; Beni, N; Christian, G; Imrek, J; Molnar, J; Novak, D; Palinkas, J; Szekely, G; Szillasi, Z; Tokesi, K; Veszpremi, V; Kapusi, A; Marian, G; Raics, P; Szabo, Z; Trocsanyi, Z L; Ujvari, B; Zilizi, G; Bansal, S; Bawa, H S; Beri, S B; Bhatnagar, V; Jindal, M; Kaur, M; Kaur, R; Kohli, J M; Mehta, M Z; Nishu, N; Saini, L K; Sharma, A; Singh, A; Singh, J B; Singh, S P; Ahuja, S; Arora, S; Bhattacharya, S; Chauhan, S; Choudhary, B C; Gupta, P; Jain, S; Jha, M; Kumar, A; Ranjan, K; Shivpuri, R K; Srivastava, A K; Choudhury, R K; Dutta, D; Kailas, S; Kataria, S K; Mohanty, A K; Pant, L M; Shukla, P; Topkar, A; Aziz, T; Guchait, M; Gurtu, A; Maity, M; Majumder, D; Majumder, G; Mazumdar, K; Nayak, A; Saha, A; Sudhakar, K; Banerjee, S; Dugad, S; Mondal, N K; Arfaei, H; Bakhshiansohi, H; Fahim, A; Jafari, A; Mohammadi Najafabadi, M; Moshaii, A; Paktinat Mehdiabadi, S; Rouhani, S; Safarzadeh, B; Zeinali, M; Felcini, M; Abbrescia, M; Barbone, L; Chiumarulo, F; Clemente, A; Colaleo, A; Creanza, D; Cuscela, G; De Filippis, N; De Palma, M; De Robertis, G; Donvito, G; Fedele, F; Fiore, L; Franco, M; Iaselli, G; Lacalamita, N; Loddo, F; Lusito, L; Maggi, G; Maggi, M; Manna, N; Marangelli, B; My, S; Natali, S; Nuzzo, S; Papagni, G; Piccolomo, S; Pierro, G A; Pinto, C; Pompili, A; Pugliese, G; Rajan, R; Ranieri, A; Romano, F; Roselli, G; Selvaggi, G; Shinde, Y; Silvestris, L; Tupputi, S; Zito, G; Abbiendi, G; Bacchi, W; Benvenuti, A C; Boldini, M; Bonacorsi, D; Braibant-Giacomelli, S; Cafaro, V D; Caiazza, S S; Capiluppi, P; Castro, A; Cavallo, F R; Codispoti, G; Cuffiani, M; D'Antone, I; Dallavalle, G M; Fabbri, F; Fanfani, A; Fasanella, D; Giacomelli, P; Giordano, V; Giunta, M; Grandi, C; Guerzoni, M; Marcellini, S; Masetti, G; Montanari, A; Navarria, F L; Odorici, F; Pellegrini, G; Perrotta, A; Rossi, A M; Rovelli, T; Siroli, G; Torromeo, G; Travaglini, R; Albergo, S; Costa, S; Potenza, R; Tricomi, A; Tuve, C; Barbagli, G; Broccolo, G; Ciulli, V; Civinini, C; D'Alessandro, R; Focardi, E; Frosali, S; Gallo, E; Genta, C; Landi, G; Lenzi, P; Meschini, M; Paoletti, S; Sguazzoni, G; Tropiano, A; Benussi, L; Bertani, M; Bianco, S; Colafranceschi, S; Colonna, D; Fabbri, F; Giardoni, M; Passamonti, L; Piccolo, D; Pierluigi, D; Ponzio, B; Russo, A; Fabbricatore, P; Musenich, R; Benaglia, A; Calloni, M; Cerati, G B; D'Angelo, P; De Guio, F; Farina, F M; Ghezzi, A; Govoni, P; Malberti, M; Malvezzi, S; Martelli, A; Menasce, D; Miccio, V; Moroni, L; Negri, P; Paganoni, M; Pedrini, D; Pullia, A; Ragazzi, S; Redaelli, N; Sala, S; Salerno, R; Tabarelli de Fatis, T; Tancini, V; Taroni, S; Buontempo, S; Cavallo, N; Cimmino, A; De Gruttola, M; Fabozzi, F; Iorio, A O M; Lista, L; Lomidze, D; Noli, P; Paolucci, P; Sciacca, C; Azzi, P; Bacchetta, N; Barcellan, L; Bellan, P; Bellato, M; Benettoni, M; Biasotto, M; Bisello, D; Borsato, E; Branca, A; Carlin, R; Castellani, L; Checchia, P; Conti, E; Dal Corso, F; De Mattia, M; Dorigo, T; Dosselli, U; Fanzago, F; Gasparini, F; Gasparini, U; Giubilato, P; Gonella, F; Gresele, A; Gulmini, M; Kaminskiy, A; Lacaprara, S; Lazzizzera, I; Margoni, M; Maron, G; Mattiazzo, S; Mazzucato, M; Meneghelli, M; Meneguzzo, A T; Michelotto, M; Montecassiano, F; Nespolo, M; Passaseo, M; Pegoraro, M; Perrozzi, L; Pozzobon, N; Ronchese, P; Simonetto, F; Toniolo, N; Torassa, E; Tosi, M; Triossi, A; Vanini, S; Ventura, S; Zotto, P; Zumerle, G; Baesso, P; Berzano, U; Bricola, S; Necchi, M M; Pagano, D; Ratti, S P; Riccardi, C; Torre, P; Vicini, A; Vitulo, P; Viviani, C; Aisa, D; Aisa, S; Babucci, E; Biasini, M; Bilei, G M; Caponeri, B; Checcucci, B; Dinu, N; Fanò, L; Farnesini, L; Lariccia, P; Lucaroni, A; Mantovani, G; Nappi, A; Piluso, A; Postolache, V; Santocchia, A; Servoli, L; Tonoiu, D; Vedaee, A; Volpe, R; Azzurri, P; Bagliesi, G; Bernardini, J; Berretta, L; Boccali, T; Bocci, A; Borrello, L; Bosi, F; Calzolari, F; Castaldi, R; Dell'Orso, R; Fiori, F; Foà, L; Gennai, S; Giassi, A; Kraan, A; Ligabue, F; Lomtadze, T; Mariani, F; Martini, L; Massa, M; Messineo, A; Moggi, A; Palla, F; Palmonari, F; Petragnani, G; Petrucciani, G; Raffaelli, F; Sarkar, S; Segneri, G; Serban, A T; Spagnolo, P; Tenchini, R; Tolaini, S; Tonelli, G; Venturi, A; Verdini, P G; Baccaro, S; Barone, L; Bartoloni, A; Cavallari, F; Dafinei, I; Del Re, D; Di Marco, E; Diemoz, M; Franci, D; Longo, E; Organtini, G; Palma, A; Pandolfi, F; Paramatti, R; Pellegrino, F; Rahatlou, S; Rovelli, C; Alampi, G; Amapane, N; Arcidiacono, R; Argiro, S; Arneodo, M; Biino, C; Borgia, M A; Botta, C; Cartiglia, N; Castello, R; Cerminara, G; Costa, M; Dattola, D; Dellacasa, G; Demaria, N; Dughera, G; Dumitrache, F; Graziano, A; Mariotti, C; Marone, M; Maselli, S; Migliore, E; Mila, G; Monaco, V; Musich, M; Nervo, M; Obertino, M M; Oggero, S; Panero, R; Pastrone, N; Pelliccioni, M; Romero, A; Ruspa, M; Sacchi, R; Solano, A; Staiano, A; Trapani, P P; Trocino, D; Vilela Pereira, A; Visca, L; Zampieri, A; Ambroglini, F; Belforte, S; Cossutti, F; Della Ricca, G; Gobbo, B; Penzo, A; Chang, S; Chung, J; Kim, D H; Kim, G N; Kong, D J; Park, H; Son, D C; Bahk, S Y; Song, S; Jung, S Y; Hong, B; Kim, H; Kim, J H; Lee, K S; Moon, D H; Park, S K; Rhee, H B; Sim, K S; Kim, J; Choi, M; Hahn, G; Park, I C; Choi, S; Choi, Y; Goh, J; Jeong, H; Kim, T J; Lee, J; Lee, S; Janulis, M; Martisiute, D; Petrov, P; Sabonis, T; Castilla Valdez, H; Sánchez Hernández, A; Carrillo Moreno, S; Morelos Pineda, A; Allfrey, P; Gray, R N C; Krofcheck, D; Bernardino Rodrigues, N; Butler, P H; Signal, T; Williams, J C; Ahmad, M; Ahmed, I; Ahmed, W; Asghar, M I; Awan, M I M; Hoorani, H R; Hussain, I; Khan, W A; Khurshid, T; Muhammad, S; Qazi, S; Shahzad, H; Cwiok, M; Dabrowski, R; Dominik, W; Doroba, K; Konecki, M; Krolikowski, J; Pozniak, K; Romaniuk, Ryszard; Zabolotny, W; Zych, P; Frueboes, T; Gokieli, R; Goscilo, L; Górski, M; Kazana, M; Nawrocki, K; Szleper, M; Wrochna, G; Zalewski, P; Almeida, N; Antunes Pedro, L; Bargassa, P; David, A; Faccioli, P; Ferreira Parracho, P G; Freitas Ferreira, M; Gallinaro, M; Guerra Jordao, M; Martins, P; Mini, G; Musella, P; Pela, J; Raposo, L; Ribeiro, P Q; Sampaio, S; Seixas, J; Silva, J; Silva, P; Soares, D; Sousa, M; Varela, J; Wöhri, H K; Altsybeev, I; Belotelov, I; Bunin, P; Ershov, Y; Filozova, I; Finger, M; Finger, M., Jr.; Golunov, A; Golutvin, I; Gorbounov, N; Kalagin, V; Kamenev, A; Karjavin, V; Konoplyanikov, V; Korenkov, V; Kozlov, G; Kurenkov, A; Lanev, A; Makankin, A; Mitsyn, V V; Moisenz, P; Nikonov, E; Oleynik, D; Palichik, V; Perelygin, V; Petrosyan, A; Semenov, R; Shmatov, S; Smirnov, V; Smolin, D; Tikhonenko, E; Vasil'ev, S; Vishnevskiy, A; Volodko, A; Zarubin, A; Zhiltsov, V; Bondar, N; Chtchipounov, L; Denisov, A; Gavrikov, Y; Gavrilov, G; Golovtsov, V; Ivanov, Y; Kim, V; Kozlov, V; Levchenko, P; Obrant, G; Orishchin, E; Petrunin, A; Shcheglov, Y; Shchetkovskiy, A; Sknar, V; Smirnov, I; Sulimov, V; Tarakanov, V; Uvarov, L; Vavilov, S; Velichko, G; Volkov, S; Vorobyev, A; Andreev, Yu; Anisimov, A; Antipov, P; Dermenev, A; Gninenko, S; Golubev, N; Kirsanov, M; Krasnikov, N; Matveev, V; Pashenkov, A; Postoev, V E; Solovey, A; Toropin, A; Troitsky, S; Baud, A; Epshteyn, V; Gavrilov, V; Ilina, N; Kaftanov, V; Kolosov, V; Kossov, M; Krokhotin, A; Kuleshov, S; Oulianov, A; Safronov, G; Semenov, S; Shreyber, I; Stolin, V; Vlasov, E; Zhokin, A; Boos, E; Dubinin, M; Dudko, L; Ershov, A; Gribushin, A; Klyukhin, V; Kodolova, O; Lokhtin, I; Petrushanko, S; Sarycheva, L; Savrin, V; Snigirev, A; Vardanyan, I; Dremin, I; Kirakosyan, M; Konovalova, N; Rusakov, S V; Vinogradov, A; Akimenko, S; Artamonov, A; Azhgirey, I; Bitioukov, S; Burtovoy, V; Grishin, V; Kachanov, V; Konstantinov, D; Krychkine, V; Levine, A; Lobov, I; Lukanin, V; Mel'nik, Y; Petrov, V; Ryutin, R; Slabospitsky, S; Sobol, A; Sytine, A; Tourtchanovitch, L; Troshin, S; Tyurin, N; Uzunian, A; Volkov, A; Adzic, P; Djordjevic, M; Jovanovic, D; Krpic, D; Maletic, D; Puzovic, J; Smiljkovic, N; Aguilar-Benitez, M; Alberdi, J; Alcaraz Maestre, J; Arce, P; Barcala, J M; Battilana, C; Burgos Lazaro, C; Caballero Bejar, J; Calvo, E; Cardenas Montes, M; Cepeda, M; Cerrada, M; Chamizo Llatas, M; Clemente, F; Colino, N; Daniel, M; De La Cruz, B; Delgado Peris, A; Diez Pardos, C; Fernandez Bedoya, C; Fernández Ramos, J P; Ferrando, A; Flix, J; Fouz, M C; Garcia-Abia, P; Garcia-Bonilla, A C; Gonzalez Lopez, O; Goy Lopez, S; Hernandez, J M; Josa, M I; Marin, J; Merino, G; Molina, J; Molinero, A; Navarrete, J J; Oller, J C; Puerta Pelayo, J; Romero, L; Santaolalla, J; Villanueva Munoz, C; Willmott, C; Yuste, C; Albajar, C; Blanco Otano, M; de Trocóniz, J F; Garcia Raboso, A; Lopez Berengueres, J O; Cuevas, J; Fernandez Menendez, J; Gonzalez Caballero, I; Lloret Iglesias, L; Naves Sordo, H; Vizan Garcia, J M; Cabrillo, I J; Calderon, A; Chuang, S H; Diaz Merino, I; Diez Gonzalez, C; Duarte Campderros, J; Fernandez, M; Gomez, G; Gonzalez Sanchez, J; Gonzalez Suarez, R; Jorda, C; Lobelle Pardo, P; Lopez Virto, A; Marco, J; Marco, R; Martinez Rivero, C; Martinez Ruiz del Arbol, P; Matorras, F; Rodrigo, T; Ruiz Jimeno, A; Scodellaro, L; Sobron Sanudo, M; Vila, I; Vilar Cortabitarte, R; Abbaneo, D; Albert, E; Alidra, M; Ashby, S; Auffray, E; Baechler, J; Baillon, P; Ball, A H; Bally, S L; Barney, D; Beaudette, F; Bellan, R; Benedetti, D; Benelli, G; Bernet, C; Bloch, P; Bolognesi, S; Bona, M; Bos, J; Bourgeois, N; Bourrel, T; Breuker, H; Bunkowski, K; Campi, D; Camporesi, T; Cano, E; Cattai, A; Chatelain, J P; Chauvey, M; Christiansen, T; Coarasa Perez, J A; Conde Garcia, A; Covarelli, R; Curé, B; De Roeck, A; Delachenal, V; Deyrail, D; Di Vincenzo, S; Dos Santos, S; Dupont, T; Edera, L M; Elliott-Peisert, A; Eppard, M; Favre, M; Frank, N; Funk, W; Gaddi, A; Gastal, M; Gateau, M; Gerwig, H; Gigi, D; Gill, K; Giordano, D; Girod, J P; Glege, F; Gomez-Reino Garrido, R; Goudard, R; Gowdy, S; Guida, R; Guiducci, L; Gutleber, J; Hansen, M; Hartl, C; Harvey, J; Hegner, B; Hoffmann, H F; Holzner, A; Honma, A; Huhtinen, M; Innocente, V; Janot, P; Le Godec, G; Lecoq, P; Leonidopoulos, C; Loos, R; Lourenço, C; Lyonnet, A; Macpherson, A; Magini, N; Maillefaud, J D; Maire, G; Mäki, T; Malgeri, L; Mannelli, M; Masetti, L; Meijers, F; Meridiani, P; Mersi, S; Meschi, E; Meynet Cordonnier, A; Moser, R; Mulders, M; Mulon, J; Noy, M; Oh, A; Olesen, G; Onnela, A; Orimoto, T; Orsini, L; Perez, E; Perinic, G; Pernot, J F; Petagna, P; Petiot, P; Petrilli, A; Pfeiffer, A; Pierini, M; Pimiä, M; Pintus, R; Pirollet, B; Postema, H; Racz, A; Ravat, S; Rew, S B; Rodrigues Antunes, J; Rolandi, G.; Rovere, M; Ryjov, V; Sakulin, H; Samyn, D; Sauce, H; Schäfer, C; Schlatter, W D; Schröder, M; Schwick, C; Sciaba, A; Segoni, I; Sharma, A; Siegrist, N; Siegrist, P; Sinanis, N; Sobrier, T; Sphicas, P; Spiga, D; Spiropulu, M; Stöckli, F; Traczyk, P; Tropea, P; Troska, J; Tsirou, A; Veillet, L; Veres, G I; Voutilainen, M; Wertelaers, P; Zanetti, M; Bertl, W; Deiters, K; Erdmann, W; Gabathuler, K; Horisberger, R; Ingram, Q; Kaestli, H C; König, S; Kotlinski, D; Langenegger, U; Meier, F; Renker, D; Rohe, T; Sibille, J; Starodumov, A; Betev, B; Caminada, L; Chen, Z; Cittolin, S; Da Silva Di Calafiori, D R; Dambach, S; Dissertori, G; Dittmar, M; Eggel, C; Eugster, J; Faber, G; Freudenreich, K; Grab, C; Hervé, A; Hintz, W; Lecomte, P; Luckey, P D; Lustermann, W; Marchica, C; Milenovic, P; Moortgat, F; Nardulli, A; Nessi-Tedaldi, F; Pape, L; Pauss, F; Punz, T; Rizzi, A; Ronga, F J; Sala, L; Sanchez, A K; Sawley, M C; Sordini, V; Stieger, B; Tauscher, L; Thea, A; Theofilatos, K; Treille, D; Trüb, P; Weber, M; Wehrli, L; Weng, J; Zelepoukine, S; Amsler, C; Chiochia, V; De Visscher, S; Regenfus, C; Robmann, P; Rommerskirchen, T; Schmidt, A; Tsirigkas, D; Wilke, L; Chang, Y H; Chen, E A; Chen, W T; Go, A; Kuo, C M; Li, S W; Lin, W; Bartalini, P; Chang, P; Chao, Y; Chen, K F; Hou, W S; Hsiung, Y; Lei, Y J; Lin, S W; Lu, R S; Schümann, J; Shiu, J G; Tzeng, Y M; Ueno, K; Velikzhanin, Y; Wang, C C; Wang, M; Adiguzel, A; Ayhan, A; Azman Gokce, A; Bakirci, M N; Cerci, S; Dumanoglu, I; Eskut, E; Girgis, S; Gurpinar, E; Hos, I; Karaman, T; Kayis Topaksu, A; Kurt, P; Önengüt, G; Önengüt Gökbulut, G; Ozdemir, K; Ozturk, S; Polatöz, A; Sogut, K; Tali, B; Topakli, H; Uzun, D; Vergili, L N; Vergili, M; Akin, I V; Aliev, T; Bilmis, S; Deniz, M; Gamsizkan, H; Guler, A M; Öcalan, K; Serin, M; Sever, R; Surat, U E; Zeyrek, M; Deliomeroglu, M; Demir, D; Gülmez, E; Halu, A; Isildak, B; Kaya, M; Kaya, O; Ozkorucuklu, S; Sonmez, N; Levchuk, L; Lukyanenko, S; Soroka, D; Zub, S; Bostock, F; Brooke, J J; Cheng, T L; Cussans, D; Frazier, R; Goldstein, J; Grant, N; Hansen, M; Heath, G P; Heath, H F; Hill, C; Huckvale, B; Jackson, J; Mackay, C K; Metson, S; Newbold, D M; Nirunpong, K; Smith, V J; Velthuis, J; Walton, R; Bell, K W; Brew, C; Brown, R M; Camanzi, B; Cockerill, D J A; Coughlan, J A; Geddes, N I; Harder, K; Harper, S; Kennedy, B W; Murray, P; Shepherd-Themistocleous, C H; Tomalin, I R; Williams, J H; Womersley, W J; Worm, S D; Bainbridge, R; Ball, G; Ballin, J; Beuselinck, R; Buchmuller, O; Colling, D; Cripps, N; Davies, G; Della Negra, M; Foudas, C; Fulcher, J; Futyan, D; Hall, G; Hays, J; Iles, G; Karapostoli, G; MacEvoy, B C; Magnan, A M; Marrouche, J; Nash, J; Nikitenko, A; Papageorgiou, A; Pesaresi, M; Petridis, K; Pioppi, M; Raymond, D M; Rompotis, N; Rose, A; Ryan, M J; Seez, C; Sharp, P; Sidiropoulos, G; Stettler, M; Stoye, M; Takahashi, M; Tapper, A; Timlin, C; Tourneur, S; Vazquez Acosta, M; Virdee, T; Wakefield, S; Wardrope, D; Whyntie, T; Wingham, M; Cole, J E; Goitom, I; Hobson, P R; Khan, A; Kyberd, P; Leslie, D; Munro, C; Reid, I D; Siamitros, C; Taylor, R; Teodorescu, L; Yaselli, I; Bose, T; Carleton, M; Hazen, E; Heering, A H; Heister, A; John, J St; Lawson, P; Lazic, D; Osborne, D; Rohlf, J; Sulak, L; Wu, S; Andrea, J; Avetisyan, A; Bhattacharya, S; Chou, J P; Cutts, D; Esen, S; Kukartsev, G; Landsberg, G; Narain, M; Nguyen, D; Speer, T; Tsang, K V; Breedon, R; Calderon De La Barca Sanchez, M; Case, M; Cebra, D; Chertok, M; Conway, J; Cox, P T; Dolen, J; Erbacher, R; Friis, E; Ko, W; Kopecky, A; Lander, R; Lister, A; Liu, H; Maruyama, S; Miceli, T; Nikolic, M; Pellett, D; Robles, J; Searle, M; Smith, J; Squires, M; Stilley, J; Tripathi, M; Vasquez Sierra, R; Veelken, C; Andreev, V; Arisaka, K; Cline, D; Cousins, R; Erhan, S; Hauser, J; Ignatenko, M; Jarvis, C; Mumford, J; Plager, C; Rakness, G; Schlein, P; Tucker, J; Valuev, V; Wallny, R; Yang, X; Babb, J; Bose, M; Chandra, A; Clare, R; Ellison, J A; Gary, J W; Hanson, G; Jeng, G Y; Kao, S C; Liu, F; Liu, H; Luthra, A; Nguyen, H; Pasztor, G; Satpathy, A; Shen, B C; Stringer, R; Sturdy, J; Sytnik, V; Wilken, R; Wimpenny, S; Branson, J G; Dusinberre, E; Evans, D; Golf, F; Kelley, R; Lebourgeois, M; Letts, J; Lipeles, E; Mangano, B; Muelmenstaedt, J; Norman, M; Padhi, S; Petrucci, A; Pi, H; Pieri, M; Ranieri, R; Sani, M; Sharma, V; Simon, S; Würthwein, F; Yagil, A; Campagnari, C; D'Alfonso, M; Danielson, T; Garberson, J; Incandela, J; Justus, C; Kalavase, P; Koay, S A; Kovalskyi, D; Krutelyov, V; Lamb, J; Lowette, S; Pavlunin, V; Rebassoo, F; Ribnik, J; Richman, J; Rossin, R; Stuart, D; To, W; Vlimant, J R; Witherell, M; Apresyan, A; Bornheim, A; Bunn, J; Chiorboli, M; Gataullin, M; Kcira, D; Litvine, V; Ma, Y; Newman, H B; Rogan, C; Timciuc, V; Veverka, J; Wilkinson, R; Yang, Y; Zhang, L; Zhu, K; Zhu, R Y; Akgun, B; Carroll, R; Ferguson, T; Jang, D W; Jun, S Y; Paulini, M; Russ, J; Terentyev, N; Vogel, H; Vorobiev, I; Cumalat, J P; Dinardo, M E; Drell, B R; Ford, W T; Heyburn, B; Luiggi Lopez, E; Nauenberg, U; Stenson, K; Ulmer, K; Wagner, S R; Zang, S L; Agostino, L; Alexander, J; Blekman, F; Cassel, D; Chatterjee, A; Das, S; Gibbons, L K; Heltsley, B; Hopkins, W; Khukhunaishvili, A; Kreis, B; Kuznetsov, V; Patterson, J R; Puigh, D; Ryd, A; Shi, X; Stroiney, S; Sun, W; Teo, W D; Thom, J; Vaughan, J; Weng, Y; Wittich, P; Beetz, C P; Cirino, G; Sanzeni, C; Winn, D; Abdullin, S; Afaq, M A; Albrow, M; Ananthan, B; Apollinari, G; Atac, M; Badgett, W; Bagby, L; Bakken, J A; Baldin, B; Banerjee, S; Banicz, K; Bauerdick, L A T; Beretvas, A; Berryhill, J; Bhat, P C; Biery, K; Binkley, M; Bloch, I; Borcherding, F; Brett, A M; Burkett, K; Butler, J N; Chetluru, V; Cheung, H W K; Chlebana, F; Churin, I; Cihangir, S; Crawford, M; Dagenhart, W; Demarteau, M; Derylo, G; Dykstra, D; Eartly, D P; Elias, J E; Elvira, V D; Evans, D; Feng, L; Fischler, M; Fisk, I; Foulkes, S; Freeman, J; Gartung, P; Gottschalk, E; Grassi, T; Green, D; Guo, Y; Gutsche, O; Hahn, A; Hanlon, J; Harris, R M; Holzman, B; Howell, J; Hufnagel, D; James, E; Jensen, H; Johnson, M; Jones, C D; Joshi, U; Juska, E; Kaiser, J; Klima, B; Kossiakov, S; Kousouris, K; Kwan, S; Lei, C M; Limon, P; Lopez Perez, J A; Los, S; Lueking, L; Lukhanin, G; Lusin, S; Lykken, J; Maeshima, K; Marraffino, J M; Mason, D; McBride, P; Miao, T; Mishra, K; Moccia, S; Mommsen, R; Mrenna, S; Muhammad, A S; Newman-Holmes, C; Noeding, C; O'Dell, V; Prokofyev, O; Rivera, R; Rivetta, C H; Ronzhin, A; Rossman, P; Ryu, S; Sekhri, V; Sexton-Kennedy, E; Sfiligoi, I; Sharma, S; Shaw, T M; Shpakov, D; Skup, E; Smith, R P; Soha, A; Spalding, W J; Spiegel, L; Suzuki, I; Tan, P; Tanenbaum, W; Tkaczyk, S; Trentadue, R; Uplegger, L; Vaandering, E W; Vidal, R; Whitmore, J; Wicklund, E; Wu, W; Yarba, J; Yumiceva, F; Yun, J C; Acosta, D; Avery, P; Barashko, V; Bourilkov, D; Chen, M; Di Giovanni, G P; Dobur, D; Drozdetskiy, A; Field, R D; Fu, Y; Furic, I K; Gartner, J; Holmes, D; Kim, B; Klimenko, S; Konigsberg, J; Korytov, A; Kotov, K; Kropivnitskaya, A; Kypreos, T; Madorsky, A; Matchev, K; Mitselmakher, G; Pakhotin, Y; Piedra Gomez, J; Prescott, C; Rapsevicius, V; Remington, R; Schmitt, M; Scurlock, B; Wang, D; Yelton, J; Ceron, C; Gaultney, V; Kramer, L; Lebolo, L M; Linn, S; Markowitz, P; Martinez, G; Rodriguez, J L; Adams, T; Askew, A; Baer, H; Bertoldi, M; Chen, J; Dharmaratna, W G D; Gleyzer, S V; Haas, J; Hagopian, S; Hagopian, V; Jenkins, M; Johnson, K F; Prettner, E; Prosper, H; Sekmen, S; Baarmand, M M; Guragain, S; Hohlmann, M; Kalakhety, H; Mermerkaya, H; Ralich, R; Vodopiyanov, I; Abelev, B; Adams, M R; Anghel, I M; Apanasevich, L; Bazterra, V E; Betts, R R; Callner, J; Castro, M A; Cavanaugh, R; Dragoiu, C; Garcia-Solis, E J; Gerber, C E; Hofman, D J; Khalatian, S; Mironov, C; Shabalina, E; Smoron, A; Varelas, N; Akgun, U; Albayrak, E A; Ayan, A S; Bilki, B; Briggs, R; Cankocak, K; Chung, K; Clarida, W; Debbins, P; Duru, F; Ingram, F D; Lae, C K; McCliment, E; Merlo, J P; Mestvirishvili, A; Miller, M J; Moeller, A; Nachtman, J; Newsom, C R; Norbeck, E; Olson, J; Onel, Y; Ozok, F; Parsons, J; Schmidt, I; Sen, S; Wetzel, J; Yetkin, T; Yi, K; Barnett, B A; Blumenfeld, B; Bonato, A; Chien, C Y; Fehling, D; Giurgiu, G; Gritsan, A V; Guo, Z J; Maksimovic, P; Rappoccio, S; Swartz, M; Tran, N V; Zhang, Y; Baringer, P; Bean, A; Grachov, O; Murray, M; Radicci, V; Sanders, S; Wood, J S; Zhukova, V; Bandurin, D; Bolton, T; Kaadze, K; Liu, A; Maravin, Y; Onoprienko, D; Svintradze, I; Wan, Z; Gronberg, J; Hollar, J; Lange, D; Wright, D; Baden, D; Bard, R; Boutemeur, M; Eno, S C; Ferencek, D; Hadley, N J; Kellogg, R G; Kirn, M; Kunori, S; Rossato, K; Rumerio, P; Santanastasio, F; Skuja, A; Temple, J; Tonjes, M B; Tonwar, S C; Toole, T; Twedt, E; Alver, B; Bauer, G; Bendavid, J; Busza, W; Butz, E; Cali, I A; Chan, M; D'Enterria, D; Everaerts, P; Gomez Ceballos, G; Hahn, K A; Harris, P; Jaditz, S; Kim, Y; Klute, M; Lee, Y J; Li, W; Loizides, C; Ma, T; Miller, M; Nahn, S; Paus, C; Roland, C; Roland, G; Rudolph, M; Stephans, G; Sumorok, K; Sung, K; Vaurynovich, S; Wenger, E A; Wyslouch, B; Xie, S; Yilmaz, Y; Yoon, A S; Bailleux, D; Cooper, S I; Cushman, P; Dahmes, B; De Benedetti, A; Dolgopolov, A; Dudero, P R; Egeland, R; Franzoni, G; Haupt, J; Inyakin, A; Klapoetke, K; Kubota, Y; Mans, J; Mirman, N; Petyt, D; Rekovic, V; Rusack, R; Schroeder, M; Singovsky, A; Zhang, J; Cremaldi, L M; Godang, R; Kroeger, R; Perera, L; Rahmat, R; Sanders, D A; Sonnek, P; Summers, D; Bloom, K; Bockelman, B; Bose, S; Butt, J; Claes, D R; Dominguez, A; Eads, M; Keller, J; Kelly, T; Kravchenko, I; Lazo-Flores, J; Lundstedt, C; Malbouisson, H; Malik, S; Snow, G R; Baur, U; Iashvili, I; Kharchilava, A; Kumar, A; Smith, K; Strang, M; Alverson, G; Barberis, E; Boeriu, O; Eulisse, G; Govi, G; McCauley, T; Musienko, Y; Muzaffar, S; Osborne, I; Paul, T; Reucroft, S; Swain, J; Taylor, L; Tuura, L; Anastassov, A; Gobbi, B; Kubik, A; Ofierzynski, R A; Pozdnyakov, A; Schmitt, M; Stoynev, S; Velasco, M; Won, S; Antonelli, L; Berry, D; Hildreth, M; Jessop, C; Karmgard, D J; Kolberg, T; Lannon, K; Lynch, S; Marinelli, N; Morse, D M; Ruchti, R; Slaunwhite, J; Warchol, J; Wayne, M; Bylsma, B; Durkin, L S; Gilmore, J; Gu, J; Killewald, P; Ling, T Y; Williams, G; Adam, N; Berry, E; Elmer, P; Garmash, A; Gerbaudo, D; Halyo, V; Hunt, A; Jones, J; Laird, E; Marlow, D; Medvedeva, T; Mooney, M; Olsen, J; Piroué, P; Stickland, D; Tully, C; Werner, J S; Wildish, T; Xie, Z; Zuranski, A; Acosta, J G; Bonnett Del Alamo, M; Huang, X T; Lopez, A; Mendez, H; Oliveros, S; Ramirez Vargas, J E; Santacruz, N; Zatzerklyany, A; Alagoz, E; Antillon, E; Barnes, V E; Bolla, G; Bortoletto, D; Everett, A; Garfinkel, A F; Gecse, Z; Gutay, L; Ippolito, N; Jones, M; Koybasi, O; Laasanen, A T; Leonardo, N; Liu, C; Maroussov, V; Merkel, P; Miller, D H; Neumeister, N; Sedov, A; Shipsey, I; Yoo, H D; Zheng, Y; Jindal, P; Parashar, N; Cuplov, V; Ecklund, K M; Geurts, F J M; Liu, J H; Maronde, D; Matveev, M; Padley, B P; Redjimi, R; Roberts, J; Sabbatini, L; Tumanov, A; Betchart, B; Bodek, A; Budd, H; Chung, Y S; de Barbaro, P; Demina, R; Flacher, H; Gotra, Y; Harel, A; Korjenevski, S; Miner, D C; Orbaker, D; Petrillo, G; Vishnevskiy, D; Zielinski, M; Bhatti, A; Demortier, L; Goulianos, K; Hatakeyama, K; Lungu, G; Mesropian, C; Yan, M; Atramentov, O; Bartz, E; Gershtein, Y; Halkiadakis, E; Hits, D; Lath, A; Rose, K; Schnetzer, S; Somalwar, S; Stone, R; Thomas, S; Watts, T L; Cerizza, G; Hollingsworth, M; Spanier, S; Yang, Z C; York, A; Asaadi, J; Aurisano, A; Eusebi, R; Golyash, A; Gurrola, A; Kamon, T; Nguyen, C N; Pivarski, J; Safonov, A; Sengupta, S; Toback, D; Weinberger, M; Akchurin, N; Berntzon, L; Gumus, K; Jeong, C; Kim, H; Lee, S W; Popescu, S; Roh, Y; Sill, A; Volobouev, I; Washington, E; Wigmans, R; Yazgan, E; Engh, D; Florez, C; Johns, W; Pathak, S; Sheldon, P; Andelin, D; Arenton, M W; Balazs, M; Boutle, S; Buehler, M; Conetti, S; Cox, B; Hirosky, R; Ledovskoy, A; Neu, C; Phillips II, D; Ronquest, M; Yohay, R; Gollapinni, S; Gunthoti, K; Harr, R; Karchin, P E; Mattson, M; Sakharov, A; Anderson, M; Bachtis, M; Bellinger, J N; Carlsmith, D; Crotty, I; Dasu, S; Dutta, S; Efron, J; Feyzi, F; Flood, K; Gray, L; Grogg, K S; Grothe, M; Hall-Wilton, R; Jaworski, M; Klabbers, P; Klukas, J; Lanaro, A; Lazaridis, C; Leonard, J; Loveless, R; Magrans de Abril, M; Mohapatra, A; Ott, G; Polese, G; Reeder, D; Savin, A; Smith, W H; Sourkov, A; Swanson, J; Weinberg, M; Wenman, D; Wensveen, M; White, A

    2010-01-01

    The CMS muon system has been aligned using cosmic-ray muons collected in 2008 and beam-halo muons from the 2008 LHC circulating beam tests. After alignment, the resolution of the most sensitive coordinate is 80 microns for the relative positions of superlayers in the same barrel chamber and 270 microns for the relative positions ofendcap chambers in the same ring structure. The resolution on the position of the central barrel chambers relative to the tracker is comprised between two extreme estimates, 200 and 700 microns, provided by two complementary studies. With minor modifications, the alignment procedures can be applied using muons from LHC collisions, leading to additional significant improvements.

  10. Radiographic assessment of knee-ankle alignment after total knee arthroplasty for varus and valgus knee osteoarthritis.

    Science.gov (United States)

    Gao, Fuqiang; Ma, Jinhui; Sun, Wei; Guo, Wanshou; Li, Zirong; Wang, Weiguo

    2017-01-01

    There are unanswered questions about knee-ankle alignment after total knee arthroplasty (TKA) for varus and valgus osteoarthritis (OA) of the knee. The aim of this retrospective study was to assess knee-ankle alignment after TKA. The study consisted of 149 patients who had undergone TKA due to varus and valgus knee OA. The alignment and angles in the selected knees and ankles were measured on full-length standing anteroposterior radiographs, both pre-operatively and post-operatively. The paired t-test and Pearson's correlation tests were used for statistical analysis. The results showed that ankle alignment correlated with knee alignment both pre-operatively and postoperatively (Pknee was corrected (Pknee-ankle alignment on the non-operative side (P>0.05). These findings indicated that routine TKA could correct the varus or valgus deformity of a knee, and improve the tilt of the ankle. Ankle alignment correlated with knee alignment both pre-operatively and postoperatively. Both pre-operative knee and ankle malalignment can be simultaneously corrected following TKA. Level III. Copyright © 2016 Elsevier B.V. All rights reserved.

  11. Dielectrophoresis of gold nanoparticles conjugated to DNA origami structures

    Directory of Open Access Journals (Sweden)

    Anja Henning-Knechtel

    2016-07-01

    Full Text Available DNA nanostructures are promising construction materials to bridge the gap between self-assembly of functional molecules and conventional top-down fabrication methods in nanotechnology. Their positioning onto specific locations of a microstructured substrate is an important task towards this aim. Here we study manipulation and positioning of pristine and of gold nanoparticle-conjugated tubular DNA origami structures using ac dielectrophoresis. The dielectrophoretic behavior was investigated employing fluorescence microscopy. For the pristine origami, a significant dielectrophoretic response was found to take place in the megahertz range, whereas, due to the higher polarizability of the metallic nanoparticles, the nanoparticle/DNA hybrid structures required a lower electrical field strength and frequency for a comparable trapping at the edges of the electrode structure. The nanoparticle conjugation additionally resulted in a remarkable alteration of the DNA structure arrangement. The growth of linear, chain-like structures in between electrodes at applied frequencies in the megahertz range was observed. The long-range chain formation is caused by a local, gold nanoparticle-induced field concentration along the DNA nanostructures, which in turn, creates dielectrophoretic forces that enable the observed self-alignment of the hybrid structures.

  12. Hybrid vehicle motor alignment

    Science.gov (United States)

    Levin, Michael Benjamin

    2001-07-03

    A rotor of an electric motor for a motor vehicle is aligned to an axis of rotation for a crankshaft of an internal combustion engine having an internal combustion engine and an electric motor. A locator is provided on the crankshaft, a piloting tool is located radially by the first locator to the crankshaft. A stator of the electric motor is aligned to a second locator provided on the piloting tool. The stator is secured to the engine block. The rotor is aligned to the crankshaft and secured thereto.

  13. Test procedure for calibration, grooming and alignment of the LDUA Optical Alignment Scope

    International Nuclear Information System (INIS)

    Potter, J.D.

    1995-01-01

    The Light Duty Utility Arm (LDUA) is a remotely operated manipulator used to enter into underground waste tanks through one of the tank risers. The LDUA must be carefully aligned with the tank riser during the installation process. The Optical Alignment Scope (OAS) is used to determine when optimum alignment has been achieved between the LDUA and the riser. This procedure is used to assure that the instrumentation and equipment comprising the OAS is properly adjusted in order to achieve its intended functions successfully

  14. STELLAR: fast and exact local alignments

    Directory of Open Access Journals (Sweden)

    Weese David

    2011-10-01

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

  15. SATCHMO-JS: a webserver for simultaneous protein multiple sequence alignment and phylogenetic tree construction.

    Science.gov (United States)

    Hagopian, Raffi; Davidson, John R; Datta, Ruchira S; Samad, Bushra; Jarvis, Glen R; Sjölander, Kimmen

    2010-07-01

    We present the jump-start simultaneous alignment and tree construction using hidden Markov models (SATCHMO-JS) web server for simultaneous estimation of protein multiple sequence alignments (MSAs) and phylogenetic trees. The server takes as input a set of sequences in FASTA format, and outputs a phylogenetic tree and MSA; these can be viewed online or downloaded from the website. SATCHMO-JS is an extension of the SATCHMO algorithm, and employs a divide-and-conquer strategy to jump-start SATCHMO at a higher point in the phylogenetic tree, reducing the computational complexity of the progressive all-versus-all HMM-HMM scoring and alignment. Results on a benchmark dataset of 983 structurally aligned pairs from the PREFAB benchmark dataset show that SATCHMO-JS provides a statistically significant improvement in alignment accuracy over MUSCLE, Multiple Alignment using Fast Fourier Transform (MAFFT), ClustalW and the original SATCHMO algorithm. The SATCHMO-JS webserver is available at http://phylogenomics.berkeley.edu/satchmo-js. The datasets used in these experiments are available for download at http://phylogenomics.berkeley.edu/satchmo-js/supplementary/.

  16. The alignment of carbon nanotubes: an effective route to extend their excellent properties to macroscopic scale.

    Science.gov (United States)

    Sun, Xuemei; Chen, Tao; Yang, Zhibin; Peng, Huisheng

    2013-02-19

    To improve the practical application of carbon nanotubes, it is critically important to extend their physical properties from the nanoscale to the macroscopic scale. Recently, chemists aligned continuous multiwalled carbon nanotube (MWCNT) sheets and fibers to produce materials with high mechanical strength and electrical conductivity. This provided an important clue to the use of MWCNTs at macroscopic scale. Researchers have made multiple efforts to optimize this aligned structure and improve the properties of MWCNT sheets and fibers. In this Account, we briefly highlight the new synthetic methods and promising applications of aligned MWCNTs for organic optoelectronic materials and devices. We describe several general methods to prepare both horizontally and perpendicularly aligned MWCNT/polymer composite films, through an easy solution or melting process. The composite films exhibit the combined properties of being flexible, transparent, and electrically conductive. These advances may pave the way to new flexible substrates for organic solar cells, sensing devices, and other related applications. Similarly, we discuss the synthesis of aligned MWCNT/polymer composite fibers with interesting mechanical and electrical properties. Through these methods, we can incorporate a wide variety of soluble or fusible polymers for such composite films and fibers. In addition, we can later introduce functional polymers with conjugated backbones or side chains to improve the properties of these composite materials. In particular, cooperative interactions between aligned MWCNTs and polymers can produce novel properties that do not occur individually. Common examples of this are two types of responsive polymers, photodeformable azobenzene-containing liquid crystalline polymer and chromatic polydiacetylene. Aligning the structure of MWCNTs induces the orientation of azobenzene-containing mesogens, and produces photodeformable polymer elastomers. This strategy also solves the long

  17. Development of a Self Aligned CMOS Process for Flash Lamp Annealed Polycrystalline Silicon TFTs

    Science.gov (United States)

    Bischoff, Paul

    The emerging active matrix liquid crystal (AMLCD) display market requires a high performing semiconductor material to meet rising standards of operation. Currently amorphous silicon (a-Si) dominates the market but it does not have the required mobility for it to be used in AMLCD manufacturing. Other materials have been developed including crystallizing a-Si into poly-silicon. A new approach to crystallization through the use of flash lamp annealing (FLA) decreases manufacturing time and greatly improves carrier mobility. Previous work on FLA silicon for the use in CMOS transistors revealed significant lateral dopant diffusion into the channel greatly increasing the minimum channel length required for a working device. This was further confounded by the gate overlap due to misalignment during lithography patterning steps. Through the use of furnace dopant activation instead of FLA dopant activation and a self aligned gate the minimum size transistor can be greatly reduced. A new lithography mask and process flow were developed for the furnace annealing and self aligned gate. Fabrication of the self aligned devices resulted in oxidation of the Molybdenum self aligned gate. Further development is needed to successfully manufacture these devices. Non-self aligned transistors were made simultaneously with self aligned devices and used the furnace activation. These devices showed an increase in sheet resistance from 250 O to 800 O and lower mobility from 380 to 40.2 V/cm2s. The lower mobility can be contributed to an increase in implanted trap density indicating furnace annealing is an inferior activation method over FLA. The minimum transistor size however was reduced from 20 to 5 mum. With improvements in the self aligned process high performing small devices can be manufactured.

  18. Googling DNA sequences on the World Wide Web.

    Science.gov (United States)

    Hajibabaei, Mehrdad; Singer, Gregory A C

    2009-11-10

    New web-based technologies provide an excellent opportunity for sharing and accessing information and using web as a platform for interaction and collaboration. Although several specialized tools are available for analyzing DNA sequence information, conventional web-based tools have not been utilized for bioinformatics applications. We have developed a novel algorithm and implemented it for searching species-specific genomic sequences, DNA barcodes, by using popular web-based methods such as Google. We developed an alignment independent character based algorithm based on dividing a sequence library (DNA barcodes) and query sequence to words. The actual search is conducted by conventional search tools such as freely available Google Desktop Search. We implemented our algorithm in two exemplar packages. We developed pre and post-processing software to provide customized input and output services, respectively. Our analysis of all publicly available DNA barcode sequences shows a high accuracy as well as rapid results. Our method makes use of conventional web-based technologies for specialized genetic data. It provides a robust and efficient solution for sequence search on the web. The integration of our search method for large-scale sequence libraries such as DNA barcodes provides an excellent web-based tool for accessing this information and linking it to other available categories of information on the web.

  19. Improved concentration and separation of particles in a 3D dielectrophoretic chip integrating focusing, aligning and trapping

    KAUST Repository

    Li, Ming

    2012-10-18

    This article presents a dielectrophoresis (DEP)-based microfluidic device with the three-dimensional (3D) microelectrode configuration for concentrating and separating particles in a continuous throughflow. The 3D electrode structure, where microelectrode array are patterned on both the top and bottom surfaces of the microchannel, is composed of three units: focusing, aligning and trapping. As particles flowing through the microfluidic channel, they are firstly focused and aligned by the funnel-shaped and parallel electrode array, respectively, before being captured at the trapping unit due to negative DEP force. For a mixture of two particle populations of different sizes or dielectric properties, with a careful selection of suspending medium and applied field, the population exhibits stronger negative DEP manipulated by the microelectrode array and, therefore, separated from the other population which is easily carried away toward the outlet due to hydrodynamic force. The functionality of the proposed microdevice was verified by concentrating different-sized polystyrene (PS) microparticles and yeast cells dynamically flowing in the microchannel. Moreover, separation based on size and dielectric properties was achieved by sorting PS microparticles, and isolating 5 μm PS particles from yeast cells, respectively. The performance of the proposed micro-concentrator and separator was also studied, including the threshold voltage at which particles begin to be trapped, variation of cell-trapping efficiency with respect to the applied voltage and flow rate, and the efficiency of separation experiments. The proposed microdevice has various advantages, including multi-functionality, improved manipulation efficiency and throughput, easy fabrication and operation, etc., which shows a great potential for biological, chemical and medical applications. © 2012 Springer-Verlag Berlin Heidelberg.

  20. Aligned, isotropic and patterned carbon nanotube substrates that control the growth and alignment of Chinese hamster ovary cells

    Energy Technology Data Exchange (ETDEWEB)

    Abdullah, Che Azurahanim Che; Asanithi, Piyapong; Brunner, Eric W; Jurewicz, Izabela; Bo, Chiara; Sear, Richard P; Dalton, Alan B [Department of Physics and Surrey Materials Institute, University of Surrey, Guildford, Surrey GU2 7XH (United Kingdom); Azad, Chihye Lewis; Ovalle-Robles, Raquel; Fang Shaoli; Lima, Marcio D; Lepro, Xavier; Collins, Steve; Baughman, Ray H, E-mail: r.sear@surrey.ac.uk [Alan G MacDiarmid NanoTech Institute, The University of Texas at Dallas, Richardson, TX 75080-3021 (United States)

    2011-05-20

    Here we culture Chinese hamster ovary cells on isotropic, aligned and patterned substrates based on multiwall carbon nanotubes. The nanotubes provide the substrate with nanoscale topography. The cells adhere to and grow on all substrates, and on the aligned substrate, the cells align strongly with the axis of the bundles of the multiwall nanotubes. This control over cell alignment is required for tissue engineering; almost all tissues consist of oriented cells. The aligned substrates are made using straightforward physical chemistry techniques from forests of multiwall nanotubes; no lithography is required to make inexpensive large-scale substrates with highly aligned nanoscale grooves. Interestingly, although the cells strongly align with the nanoscale grooves, only a few also elongate along this axis: alignment of the cells does not require a pronounced change in morphology of the cell. We also pattern the nanotube bundles over length scales comparable to the cell size and show that the cells follow this pattern.

  1. Novel Real-time Alignment and Calibration of the LHCb detector in Run2

    Science.gov (United States)

    Martinelli, Maurizio; LHCb Collaboration

    2017-10-01

    LHCb has introduced a novel real-time detector alignment and calibration strategy for LHC Run2. Data collected at the start of the fill are processed in a few minutes and used to update the alignment parameters, while the calibration constants are evaluated for each run. This procedure improves the quality of the online reconstruction. For example, the vertex locator is retracted and reinserted for stable beam conditions in each fill to be centred on the primary vertex position in the transverse plane. Consequently its position changes on a fill-by-fill basis. Critically, this new real-time alignment and calibration procedure allows identical constants to be used in the online and offline reconstruction, thus improving the correlation between triggered and offline-selected events. This offers the opportunity to optimise the event selection in the trigger by applying stronger constraints. The required computing time constraints are met thanks to a new dedicated framework using the multi-core farm infrastructure for the trigger. The motivation for a real-time alignment and calibration of the LHCb detector is discussed from both the operational and physics performance points of view. Specific challenges of this novel configuration are discussed, as well as the working procedures of the framework and its performance.

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

    Science.gov (United States)

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

    2006-08-15

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

  3. Degradation and half-life of DNA present in biomass from a genetically-modified organism during land application.

    Science.gov (United States)

    Halter, Mathew C; Zahn, James A

    2017-02-01

    White biotechnology has made a positive impact on the chemical industry by providing safer, more efficient chemical manufacturing processes that have reduced the use of toxic chemicals, harsh reaction conditions, and expensive metal catalysts, which has improved alignment with the principles of Green Chemistry. The genetically-modified (GM) biocatalysts that are utilized in these processes are typically separated from high-value products and then recycled, or eliminated. Elimination routes include disposal in sanitary landfills, incineration, use as a fuel, animal feed, or reuse as an agricultural soil amendment or other value-added products. Elimination routes that have the potential to impact the food chain or environment have been more heavily scrutinized for the fate and persistence of biological products. In this study, we developed and optimized a method for monitoring the degradation of strain-specific DNA markers from a genetically-modified organism (GMO) used for the commercial production of 1,3-propanediol. Laboratory and field tests showed that a marker for heterologous DNA in the GM organism was no longer detectable by end-point polymerase chain reaction (PCR) after 14 days. The half-life of heterologous DNA was increased by 17% (from 42.4 to 49.7 h) after sterilization of the soil from a field plot, which indicated that abiotic factors were important in degradation of DNA under field conditions. There was no evidence for horizontal transfer of DNA target sequences from the GMO to viable organisms present in the soil.

  4. Drive system alignment calibration of a microgravity drop tower of novel design

    Science.gov (United States)

    Trunins, J.; Osborne, B. P.; Augousti, A.

    2013-06-01

    We report here the calibration of the drive system of a new scientific facility for production of microgravity, operating on a novel design of electromagnetically driven platform. The construction achieves the design specification of alignment of the guide rails to better than 0.254mm across the entire guide rail height of 8m, despite a small lean to the right (within tolerance) and it was noted that this alignment is improved by the presence of the trolley that carries the platform.

  5. Cost-effective sequencing of full-length cDNA clones powered by a de novo-reference hybrid assembly.

    Science.gov (United States)

    Kuroshu, Reginaldo M; Watanabe, Junichi; Sugano, Sumio; Morishita, Shinichi; Suzuki, Yutaka; Kasahara, Masahiro

    2010-05-07

    Sequencing full-length cDNA clones is important to determine gene structures including alternative splice forms, and provides valuable resources for experimental analyses to reveal the biological functions of coded proteins. However, previous approaches for sequencing cDNA clones were expensive or time-consuming, and therefore, a fast and efficient sequencing approach was demanded. We developed a program, MuSICA 2, that assembles millions of short (36-nucleotide) reads collected from a single flow cell lane of Illumina Genome Analyzer to shotgun-sequence approximately 800 human full-length cDNA clones. MuSICA 2 performs a hybrid assembly in which an external de novo assembler is run first and the result is then improved by reference alignment of shotgun reads. We compared the MuSICA 2 assembly with 200 pooled full-length cDNA clones finished independently by the conventional primer-walking using Sanger sequencers. The exon-intron structure of the coding sequence was correct for more than 95% of the clones with coding sequence annotation when we excluded cDNA clones insufficiently represented in the shotgun library due to PCR failure (42 out of 200 clones excluded), and the nucleotide-level accuracy of coding sequences of those correct clones was over 99.99%. We also applied MuSICA 2 to full-length cDNA clones from Toxoplasma gondii, to confirm that its ability was competent even for non-human species. The entire sequencing and shotgun assembly takes less than 1 week and the consumables cost only approximately US$3 per clone, demonstrating a significant advantage over previous approaches.

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

    Science.gov (United States)

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

    2006-12-15

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

  7. Enterprise strategic alignment method: a cross-disciplinary capability-driven approach

    NARCIS (Netherlands)

    Aldea, Adina

    2017-01-01

    The environment of organisations is changing more rapidly in the recent years, which makes it increasingly more difficult to stay competitive. Organisations need to ensure that when they make transformations, they focus on maintaining or improving their strategic alignment. However, the current

  8. Establishment of 3D culture and induction of osteogenic differentiation of pre-osteoblasts using wet-collected aligned scaffolds

    Energy Technology Data Exchange (ETDEWEB)

    Ding, Huifen [Hubei-MOSTKLOS & KLOBM, School and Hospital of Stomatology, Wuhan University, Wuhan 430079 (China); Chongqing Affiliated Hospital of Stomatology, Chongqing University of Medical Sciences, Chongqing 400015 (China); Zhong, Junwen [Wuhan National Laboratory for Optoelectronics, School of Optical and Electronic Information, Huazhong University of Science and Technology, Wuhan 430074 (China); Xu, Fei; Song, Fangfang; Yin, Miao; Wu, Yanru; Hu, Qiyi [Hubei-MOSTKLOS & KLOBM, School and Hospital of Stomatology, Wuhan University, Wuhan 430079 (China); Wang, Jiawei, E-mail: wangjwei@hotmail.com [Hubei-MOSTKLOS & KLOBM, School and Hospital of Stomatology, Wuhan University, Wuhan 430079 (China)

    2017-02-01

    Aligned fibrous scaffolds have attracted much interest in bone tissue engineering, because they are supposed to induce osteogenic differentiation. For the first time, aligned silk fibroin nanofibres were loosely packed using a novel wet-collection electrospinning method. Moreover, three-dimensional (3D) culture of MC3T3-E1 pre-osteoblasts was established on these fibrous scaffolds. Physicochemical properties of the scaffolds and the behaviour of MC3T3-E1 pre-osteoblasts on the scaffolds were analysed and compared with scaffolds obtained using traditional method. Ethanol bath improved the uniformity and alignment of the fibres and increased the thickness and porosity of the scaffolds. Structures of the fibres were well maintained after immediate crosslinking in ethanol. Cells on the wet-collected scaffolds exhibited more ordered arrangement and elongated morphology as well as faster and deeper infiltration. The ordered infiltration resulted in the establishment of the 3D culture of cells, promoting proliferation and osteogenic differentiation of the pre-osteoblasts. Thus, the wet-collected aligned scaffolds with improved topographical and physicochemical properties presents significant potential application in bone regeneration. - Highlights: • Aligned silk fibroin nanofibres were loosely packed using a novel wet-collection electrospinning method. • Structural properties of the aligned nanofibres were improved. • Three-dimensional culture of MC3T3-E1 pre-osteoblasts was established. • The arrangement, morphology, infiltration, proliferation and osteogenic differentiation of cells were enhanced.

  9. Chromatic bifocus alignment system for SR stepper

    International Nuclear Information System (INIS)

    Miyatake, Tsutomu

    1991-01-01

    A new alignment system developed for synchrotron radiation (SR) X-ray stepper is described. The alignment system has three key elements as follows. The first is a chromatic bifocus optics which observe high contrast bright images of alignment marks printed on a mask and a wafer. The second is broad band light illumination to observe the wafer alignment mark images which is unaffected by resist film coated on a wafer. The third is a new correlation function which is used in measuring of displacement between a mask and a wafer. The alignment system has achieved alignment accuracy on the order of 0.01 μm. The experimental results of this alignment system are discussed in this paper. (author)

  10. Intrinsic alignment of redMaPPer clusters: cluster shape-matter density correlation

    Science.gov (United States)

    van Uitert, Edo; Joachimi, Benjamin

    2017-07-01

    We measure the alignment of the shapes of galaxy clusters, as traced by their satellite distributions, with the matter density field using the public redMaPPer catalogue based on Sloan Digital Sky Survey-Data Release 8 (SDSS-DR8), which contains 26 111 clusters up to z ˜ 0.6. The clusters are split into nine redshift and richness samples; in each of them, we detect a positive alignment, showing that clusters point towards density peaks. We interpret the measurements within the tidal alignment paradigm, allowing for a richness and redshift dependence. The intrinsic alignment (IA) amplitude at the pivot redshift z = 0.3 and pivot richness λ = 30 is A_IA^gen=12.6_{-1.2}^{+1.5}. We obtain tentative evidence that the signal increases towards higher richness and lower redshift. Our measurements agree well with results of maxBCG clusters and with dark-matter-only simulations. Comparing our results to the IA measurements of luminous red galaxies, we find that the IA amplitude of galaxy clusters forms a smooth extension towards higher mass. This suggests that these systems share a common alignment mechanism, which can be exploited to improve our physical understanding of IA.

  11. Tracing magnetic fields with aligned grains

    International Nuclear Information System (INIS)

    Lazarian, A.

    2007-01-01

    Magnetic fields play a crucial role in various astrophysical processes, including star formation, accretion of matter, transport processes (e.g., transport of heat), and cosmic rays. One of the easiest ways to determine the magnetic field direction is via polarization of radiation resulting from extinction or/and emission by aligned dust grains. Reliability of interpretation of the polarization maps in terms of magnetic fields depends on how well we understand the grain-alignment theory. Explaining what makes grains aligned has been one of the big issues of the modern astronomy. Numerous exciting physical effects have been discovered in the course of research undertaken in this field. As both the theory and observations matured, it became clear that the grain-alignment phenomenon is inherent not only in diffuse interstellar medium or molecular clouds but also is a generic property of the dust in circumstellar regions, interplanetary space and cometary comae. Currently the grain-alignment theory is a predictive one, and its results nicely match observations. Among its predictions is a subtle phenomenon of radiative torques. This phenomenon, after having stayed in oblivion for many years after its discovery, is currently viewed as the most powerful means of alignment. In this article, I shall review the basic physical processes involved in grain alignment, and the currently known mechanisms of alignment. I shall also discuss possible niches for different alignment mechanisms. I shall dwell on the importance of the concept of grain helicity for understanding of many properties of grain alignment, and shall demonstrate that rather arbitrarily shaped grains exhibit helicity when they interact with gaseous and radiative flows

  12. MEMS Integrated Submount Alignment for Optoelectronics

    Science.gov (United States)

    Shakespeare, W. Jeffrey; Pearson, Raymond A.; Grenestedt, Joachim L.; Hutapea, Parsaoran; Gupta, Vikas

    2005-02-01

    One of the most expensive and time-consuming production processes for single-mode fiber-optic components is the alignment of the photonic chip or waveguide to the fiber. The alignment equipment is capital intensive and usually requires trained technicians to achieve desired results. Current technology requires active alignment since tolerances are only ~0.2 μ m or less for a typical laser diode. This is accomplished using piezoelectric actuated stages and active optical feedback. Joining technologies such as soldering, epoxy bonding, or laser welding may contribute significant postbond shift, and final coupling efficiencies are often less than 80%. This paper presents a method of adaptive optical alignment to freeze in place directly on an optical submount using a microelectromechanical system (MEMS) shape memory alloy (SMA) actuation technology. Postbond shift is eliminated since the phase change is the alignment actuation. This technology is not limited to optical alignment but can be applied to a variety of MEMS actuations, including nano-actuation and nano-alignment for biomedical applications. Experimental proof-of-concept results are discussed, and a simple analytical model is proposed to predict the stress strain behavior of the optical submount. Optical coupling efficiencies and alignment times are compared with traditional processes. The feasibility of this technique in high-volume production is discussed.

  13. A new structural framework for integrating replication protein A into DNA processing machinery

    Energy Technology Data Exchange (ETDEWEB)

    Brosey, Chris; Yan, Chunli; Tsutakawa, Susan; Heller, William; Rambo, Robert; Tainer, John; Ivanov, Ivaylo; Chazin, Walter

    2013-01-17

    By coupling the protection and organization of single-stranded DNA (ssDNA) with recruitment and alignment of DNA processing factors, replication protein A (RPA) lies at the heart of dynamic multi-protein DNA processing machinery. Nevertheless, how RPA coordinates biochemical functions of its eight domains remains unknown. We examined the structural biochemistry of RPA's DNA-binding activity, combining small-angle X-ray and neutron scattering with all-atom molecular dynamics simulations to investigate the architecture of RPA's DNA-binding core. The scattering data reveal compaction promoted by DNA binding; DNA-free RPA exists in an ensemble of states with inter-domain mobility and becomes progressively more condensed and less dynamic on binding ssDNA. Our results contrast with previous models proposing RPA initially binds ssDNA in a condensed state and becomes more extended as it fully engages the substrate. Moreover, the consensus view that RPA engages ssDNA in initial, intermediate and final stages conflicts with our data revealing that RPA undergoes two (not three) transitions as it binds ssDNA with no evidence for a discrete intermediate state. These results form a framework for understanding how RPA integrates the ssDNA substrate into DNA processing machinery, provides substrate access to its binding partners and promotes the progression and selection of DNA processing pathways.

  14. NMR studies of the exocyclic 1,N6-ethenodeoxyadenosine adduct (εdA) opposite thymidine in a DNA duplex. Nonplanar alignment of εdA(anti) and dT(anti) at the lesion site

    International Nuclear Information System (INIS)

    Kouchakdjian, M.; Patel, D.J.; Eisenberg, M.; Yarema, K.; Basu, A.; Essigmann, J.

    1991-01-01

    Two-dimensional proton NMR studies are reported on the complementary d(C-A-T-G-T-G-T-A-C)·d(G-T-A-C-εA-C-A-T-G) nonanucleotide duplex (designated εdA·dT 9-mer duplex) containing 1,N 6 -ethenodeoxyadenosine (εdA), a carcinogen-DNA adduct, positioned opposite thymidine in the center of the helix. The authors NMR studies have focused on the conformation of the εdA·dT 9-mer duplex at neutral pH with emphasis on defining the alignment at the dT5·εdA14 lesion site. The through-space NOE distance connectivities establish that both dT5 and εdA14 adopt anti glycosidic torsion angles, are directed into the interior of the helix, and stack with flanking Watson-Crick dG4·dC15 and dG6·dC13 pairs. Furthermore, the d(G4-T5-G6)·d(C13-εA14-C15) trinucleotide segment centered about the dT5·εdA14 lesion site adopts a right-handed helical conformation in solution. Energy minimization computations were undertaken starting from six different alignments of dT5(anti) and εdA14(anti) at the lesion site and were guided by distance constraints defined by lower and upper bounds estimated from NOESY data sets on the εdA·dT 9-mer duplex. The NMR data are consistent with a nonplanar alignment of εdA14(anti) and dT5(anti) with dT5 displaced toward the flanking dG4·dC15 base pair within the d(G4-T5-G6)·d(C13-εA14-C15) segment of the εdA·dT 9-mer duplex

  15. Improving the yield and quality of DNA isolated from white-rot fungi.

    Science.gov (United States)

    Kuhad, R C; Kapoor, R K; Lal, R

    2004-01-01

    A new simple method used to eliminate polysaccharides that cause problems during DNA isolation was established for 6 different white-rot fungi using 1% hexadecyltrimethylammonium bromide (CTAB) as wash buffer and followed by centrifugation. Variation in the DNA yield and quality was ascertained using precipitating agents, detergents and cell-wall-hydrolyzing chitinase. Considerable amount of exopolysaccharides from fungal biomass was removed with the use of 1% CTAB wash buffer followed by centrifugation. The DNA varied in terms of yield and quality. For the DNA extraction use of 2% SDS in extraction buffer worked best for Pycnoporus cinnabarinus, Cyathus bulleri, Cyathus striatus and Cyathus stercoreus, while 2% CTAB worked best for Phanerochaete chrysosporium and Pleurotus ostreatus. Elimination of phenol and use of absolute ethanol for precipitating DNA resulted in good yield and quality of DNA. This DNA was amenable to restriction endonuclease digestion.

  16. A cross-species alignment tool (CAT)

    DEFF Research Database (Denmark)

    Li, Heng; Guan, Liang; Liu, Tao

    2007-01-01

    BACKGROUND: The main two sorts of automatic gene annotation frameworks are ab initio and alignment-based, the latter splitting into two sub-groups. The first group is used for intra-species alignments, among which are successful ones with high specificity and speed. The other group contains more...... sensitive methods which are usually applied in aligning inter-species sequences. RESULTS: Here we present a new algorithm called CAT (for Cross-species Alignment Tool). It is designed to align mRNA sequences to mammalian-sized genomes. CAT is implemented using C scripts and is freely available on the web...... at http://xat.sourceforge.net/. CONCLUSIONS: Examined from different angles, CAT outperforms other extant alignment tools. Tested against all available mouse-human and zebrafish-human orthologs, we demonstrate that CAT combines the specificity and speed of the best intra-species algorithms, like BLAT...

  17. Methods in ALFA Alignment

    CERN Document Server

    Melendez, Jordan

    2014-01-01

    This note presents two model-independent methods for use in the alignment of the ALFA forward detectors. Using a Monte Carlo simulated LHC run at \\beta = 90m and \\sqrt{s} = 7 TeV, the Kinematic Peak alignment method is utilized to reconstruct the Mandelstam momentum transfer variable t for single-diractive protons. The Hot Spot method uses fluctuations in the hitmap density to pinpoint particular regions in the detector that could signal a misalignment. Another method uses an error function fit to find the detector edge. With this information, the vertical alignment can be determined.

  18. Multiple Whole Genome Alignments Without a Reference Organism

    Energy Technology Data Exchange (ETDEWEB)

    Dubchak, Inna; Poliakov, Alexander; Kislyuk, Andrey; Brudno, Michael

    2009-01-16

    Multiple sequence alignments have become one of the most commonly used resources in genomics research. Most algorithms for multiple alignment of whole genomes rely either on a reference genome, against which all of the other sequences are laid out, or require a one-to-one mapping between the nucleotides of the genomes, preventing the alignment of recently duplicated regions. Both approaches have drawbacks for whole-genome comparisons. In this paper we present a novel symmetric alignment algorithm. The resulting alignments not only represent all of the genomes equally well, but also include all relevant duplications that occurred since the divergence from the last common ancestor. Our algorithm, implemented as a part of the VISTA Genome Pipeline (VGP), was used to align seven vertebrate and sixDrosophila genomes. The resulting whole-genome alignments demonstrate a higher sensitivity and specificity than the pairwise alignments previously available through the VGP and have higher exon alignment accuracy than comparable public whole-genome alignments. Of the multiple alignment methods tested, ours performed the best at aligning genes from multigene families?perhaps the most challenging test for whole-genome alignments. Our whole-genome multiple alignments are available through the VISTA Browser at http://genome.lbl.gov/vista/index.shtml.

  19. DNA methylation and temperature stress in an Antarctic polychaete, Spiophanes tcherniai.

    Science.gov (United States)

    Marsh, Adam G; Pasqualone, Annamarie A

    2014-01-01

    Epigenetic modifications of DNA and histones are a primary mechanism by which gene expression activities may be modified in response to environmental stimuli. Here we characterize patterns of methyl-cytosine composition in the marine polychaete Spiophanes tcherniai from McMurdo Sound, Antarctica. We cultured adult worms at two temperatures, -1.5°C (ambient control) and +4°C (warm treatment), for 4 weeks. We observed a rapid capacity for S. tcherniai organismal respiration rates and underlying catalytic rates of citrate synthase at +4°C to return to control levels in less than 4 weeks. We profiled changes in the methylation states of CpG sites in these treatments using an NGS strategy to computationally reconstruct and quantify methylation status across the genome. In our analysis we recovered 120,000 CpG sites in assembled contigs from both treatments. Of those, we were able to align 28,000 CpG sites in common between the two sample groups. In comparing these aligned sites between treatments, only 3000 (11%) evidenced a change in methylation state, but over 85% of changes involved a gain of a 5-methyl group on a CpG site (net increase in methyation). The ability to score CpG sites as partially methylated among gDNA copies in a sample opens up a new avenue for assessing DNA methylation responses to changing environments. By quantitatively distinguishing a "mixed" population of copies of one CpG site, we can begin to identify dynamic, non-binary, continuous-response reactions in DNA methylation intensity or density that previously may have been overlooked as noise.

  20. DNA Methylation and Temperature Stress in an Antarctic Polychaete, Spiophanes tcherniai

    Directory of Open Access Journals (Sweden)

    Adam G. Marsh

    2014-05-01

    Full Text Available Epigenetic modifications of DNA and histones are a primary mechanism by which gene expression activities may be modified in response to environmental stimuli. Here we characterize patterns of methyl-cytosine composition in the marine polychaete emph{Spiophanes tcherniai} from McMurdo Sound, Antarctica. We cultured adult worms at two temperatures, -1.5 C (ambient control and +4 C (warm treatment, for four weeks. We observed a rapid capacity for emph{S. tcherniai} organismal respiration rates and underlying catalytic rates of citrate synthase to acclimate at +4 C and return to control levels. We profiled changes in the methylation states of CpG sites in these treatments using an NGS strategy to computationally reconstruct and quantify methylation status across the genome. In our analysis we recovered 120,000 CpG sites in assembled contigs from both treatments. Of those, we were able to align 28,000 CpG sites in common between the two sample groups. In comparing these aligned sites between treatments, only 3,000 (11% evidenced a change in methylation state, but over 85% of changes involved a gain of a 5-methyl group on a CpG site (net increase in methyation. The ability to score CpG sites as partially methylated among gDNA copies in a sample opens up a new avenue for assessing DNA methylation responses to changing environments. By quantitatively distinguishing a ``mixed'' population of copies of one CpG site, we can begin to identify dynamic, non-binary, continuous-response reactions in DNA methylation intensity or density that previously may have been overlooked as noise.

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

    Directory of Open Access Journals (Sweden)

    Zheng Wang

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

  2. Paramagnetic decoration of DNA origami nanostructures by Eu³⁺ coordination.

    Science.gov (United States)

    Opherden, Lars; Oertel, Jana; Barkleit, Astrid; Fahmy, Karim; Keller, Adrian

    2014-07-15

    The folding of DNA into arbitrary two- and three-dimensional shapes, called DNA origami, represents a powerful tool for the synthesis of functional nanostructures. Here, we present the first approach toward the paramagnetic functionalization of DNA origami nanostructures by utilizing postassembly coordination with Eu(3+) ions. In contrast to the usual formation of toroidal dsDNA condensates in the presence of trivalent cations, planar as well as rod-like DNA origami maintain their shape and monomeric state even under high loading with the trivalent lanthanide. Europium coordination was demonstrated by the change in Eu(3+) luminescence upon binding to the two DNA origami. Their natural circular dichroism in the Mg(2+)- and Eu(3+)-bound state was found to be very similar to that of genomic DNA, evidencing little influence of the DNA origami superstructure on the local chirality of the stacked base pairs. In contrast, the magnetic circular dichroism of the Mg(2+)-bound DNA origami deviates from that of genomic DNA. Furthermore, the lanthanide affects the magnetic properties of DNA in a superstructure-dependent fashion, indicative of the existence of superstructure-specific geometry of Eu(3+) binding sites in the DNA origami that are not formed in genomic DNA. This simple approach lays the foundation for the generation of magneto-responsive DNA origami nanostructures. Such systems do not require covalent modifications and can be used for the magnetic manipulation of DNA nanostructures or for the paramagnetic alignment of molecules in NMR spectroscopy.

  3. Alignment system for SGII-Up laser facility

    Science.gov (United States)

    Gao, Yanqi; Cui, Yong; Li, Hong; Gong, Lei; Lin, Qiang; Liu, Daizhong; Zhu, Baoqiang; Ma, Weixin; Zhu, Jian; Lin, Zunqi

    2018-03-01

    The SGII-Up laser facility in Shanghai is one of the most important high-power laser facilities in China. It is designed to obtain 24 kJ (3ω) of energy with a square pulse of 3 ns using eight laser beams (two bundles). To satisfy the requirements for the safety, efficiency, and quality, an alignment system is developed for this facility. This alignment system can perform automatic alignment of the preamplifier system, main amplifier system, and harmonic conversion system within 30 min before every shot during the routine operation of the facility. In this article, an overview of the alignment system is first presented. Then, its alignment characteristics are discussed, along with the alignment process. Finally, experimental results, including the alignment results and the facility performance, are reported. The results show that the far-field beam pointing alignment accuracy is better than 3 μrad, and the alignment error of the near-field beam centering is no larger than 1 mm. These satisfy the design requirements very well.

  4. Radioactively labelled DNA probes for crop improvement. Proceedings of a final research co-ordination meeting

    Energy Technology Data Exchange (ETDEWEB)

    NONE

    2001-11-01

    With the advent of DNA molecular marker technology in the 1980s plant breeding had a new and powerful tool with which to increase its efficacy. Such markers are abundant and directly reveal information about the genotype and therefore are more useful than simple phenotypic markers. In plant breeding applications, molecular markers reveal information about variability and genetic relationships, and enable genetic mapping, which greatly assists the breeder in selection of parents and progeny, as well as in management of breeding strategies. Furthermore, molecular markers linked to phenotypic traits permit very early selection of superior progenies from breeding populations, therefore significantly reducing the need for field testing and greatly increasing efficiency of plant breeding programmes. For this to occur the oligonucleotide probes for labelling genetic markers and/or the primers for polymerase chain reactions to amplify genetic markers needed to be also accessible to scientists in developing Member States. In addition, technical information, training and troubleshooting were needed to support the utilization of DNA markers. In the early 1990s there was a dramatic increase in requests for access to this technology. This co-ordinated research project (CRP) facilitated the transfer of molecular marker technology, in terms of both material and information, from advanced laboratories to assist breeding programmes in developing countries. Two other CRPs were conducted concurrently in order to assist developing Member States to utilise molecular markers - Application of DNA Based Marker Mutations for Improvement of Cereals and other Sexually Reproduced Crop Plants, and Use of Novel DNA Fingerprinting Techniques for the Detection and Characterisation of Genetic Variation in Vegetatively Propagated Crops (IAEA-TECDOC-1010 and IAEA-TECDOC-1047, respectively). The present CRP built upon the success of the former projects by ensuring the availability of probes

  5. Radioactively labelled DNA probes for crop improvement. Proceedings of a final research co-ordination meeting

    International Nuclear Information System (INIS)

    2001-11-01

    With the advent of DNA molecular marker technology in the 1980s plant breeding had a new and powerful tool with which to increase its efficacy. Such markers are abundant and directly reveal information about the genotype and therefore are more useful than simple phenotypic markers. In plant breeding applications, molecular markers reveal information about variability and genetic relationships, and enable genetic mapping, which greatly assists the breeder in selection of parents and progeny, as well as in management of breeding strategies. Furthermore, molecular markers linked to phenotypic traits permit very early selection of superior progenies from breeding populations, therefore significantly reducing the need for field testing and greatly increasing efficiency of plant breeding programmes. For this to occur the oligonucleotide probes for labelling genetic markers and/or the primers for polymerase chain reactions to amplify genetic markers needed to be also accessible to scientists in developing Member States. In addition, technical information, training and troubleshooting were needed to support the utilization of DNA markers. In the early 1990s there was a dramatic increase in requests for access to this technology. This co-ordinated research project (CRP) facilitated the transfer of molecular marker technology, in terms of both material and information, from advanced laboratories to assist breeding programmes in developing countries. Two other CRPs were conducted concurrently in order to assist developing Member States to utilise molecular markers - Application of DNA Based Marker Mutations for Improvement of Cereals and other Sexually Reproduced Crop Plants, and Use of Novel DNA Fingerprinting Techniques for the Detection and Characterisation of Genetic Variation in Vegetatively Propagated Crops (IAEA-TECDOC-1010 and IAEA-TECDOC-1047, respectively). The present CRP built upon the success of the former projects by ensuring the availability of probes

  6. A k-mer-based barcode DNA classification methodology based on spectral representation and a neural gas network.

    Science.gov (United States)

    Fiannaca, Antonino; La Rosa, Massimo; Rizzo, Riccardo; Urso, Alfonso

    2015-07-01

    In this paper, an alignment-free method for DNA barcode classification that is based on both a spectral representation and a neural gas network for unsupervised clustering is proposed. In the proposed methodology, distinctive words are identified from a spectral representation of DNA sequences. A taxonomic classification of the DNA sequence is then performed using the sequence signature, i.e., the smallest set of k-mers that can assign a DNA sequence to its proper taxonomic category. Experiments were then performed to compare our method with other supervised machine learning classification algorithms, such as support vector machine, random forest, ripper, naïve Bayes, ridor, and classification tree, which also consider short DNA sequence fragments of 200 and 300 base pairs (bp). The experimental tests were conducted over 10 real barcode datasets belonging to different animal species, which were provided by the on-line resource "Barcode of Life Database". The experimental results showed that our k-mer-based approach is directly comparable, in terms of accuracy, recall and precision metrics, with the other classifiers when considering full-length sequences. In addition, we demonstrate the robustness of our method when a classification is performed task with a set of short DNA sequences that were randomly extracted from the original data. For example, the proposed method can reach the accuracy of 64.8% at the species level with 200-bp fragments. Under the same conditions, the best other classifier (random forest) reaches the accuracy of 20.9%. Our results indicate that we obtained a clear improvement over the other classifiers for the study of short DNA barcode sequence fragments. Copyright © 2015 Elsevier B.V. All rights reserved.

  7. Vertically aligned carbon nanotubes as anode and air-cathode in single chamber microbial fuel cells

    Science.gov (United States)

    Amade, R.; Moreno, H. A.; Hussain, S.; Vila-Costa, M.; Bertran, E.

    2016-10-01

    Electrode optimization in microbial fuel cells is a key issue to improve the power output and cell performance. Vertically aligned carbon nanotubes (VACNTs) grown on low cost stainless-steel mesh present an attractive approach to increase the cell performance while avoiding the use of expensive Pt-based materials. In comparison with non-aligned carbon nanotubes (NACNTs), VACNTs increase the oxygen reduction reaction taking place at the cathode by a factor of two. In addition, vertical alignment also increases the power density up to 2.5 times with respect to NACNTs. VACNTs grown at the anode can further improve the cell performance by increasing the electrode surface area and thus the electron transfer between bacteria and the electrode. The maximum power density obtained using VACNTs was 14 mW/m2 and 160 mV output voltage.

  8. Single Molecule Atomic Force Microscopy Studies of Photosensitized Singlet Oxygen Behavior on a DNA Origami Template

    DEFF Research Database (Denmark)

    Helmig, Sarah Wendelboe; Rotaru, Alexandru; Arian, Dumitru

    2010-01-01

    DNA origami, the folding of a long single-stranded DNA sequence (scaffold strand) by hundreds of short synthetic oligonucleotides (staple strands) into parallel aligned helices, is a highly efficient method to form advanced self-assembled DNA-architectures. Since molecules and various materials can...... be conjugated to each of the short staple strands, the origami method offers a unique possibility of arranging molecules and materials in well-defined positions on a structured surface. Here we combine the action of light with AFM and DNA nanostructures to study the production of singlet oxygen from a single...... photosensitizer molecule conjugated to a selected DNA origami staple strand on an origami structure. We demonstrate a distance-dependent oxidation of organic moieties incorporated in specific positions on DNA origami by singlet oxygen produced from a single photosensitizer located at the center of each origami....

  9. Surveying alignment-free features for Ortholog detection in related yeast proteomes by using supervised big data classifiers.

    Science.gov (United States)

    Galpert, Deborah; Fernández, Alberto; Herrera, Francisco; Antunes, Agostinho; Molina-Ruiz, Reinaldo; Agüero-Chapin, Guillermin

    2018-05-03

    The development of new ortholog detection algorithms and the improvement of existing ones are of major importance in functional genomics. We have previously introduced a successful supervised pairwise ortholog classification approach implemented in a big data platform that considered several pairwise protein features and the low ortholog pair ratios found between two annotated proteomes (Galpert, D et al., BioMed Research International, 2015). The supervised models were built and tested using a Saccharomycete yeast benchmark dataset proposed by Salichos and Rokas (2011). Despite several pairwise protein features being combined in a supervised big data approach; they all, to some extent were alignment-based features and the proposed algorithms were evaluated on a unique test set. Here, we aim to evaluate the impact of alignment-free features on the performance of supervised models implemented in the Spark big data platform for pairwise ortholog detection in several related yeast proteomes. The Spark Random Forest and Decision Trees with oversampling and undersampling techniques, and built with only alignment-based similarity measures or combined with several alignment-free pairwise protein features showed the highest classification performance for ortholog detection in three yeast proteome pairs. Although such supervised approaches outperformed traditional methods, there were no significant differences between the exclusive use of alignment-based similarity measures and their combination with alignment-free features, even within the twilight zone of the studied proteomes. Just when alignment-based and alignment-free features were combined in Spark Decision Trees with imbalance management, a higher success rate (98.71%) within the twilight zone could be achieved for a yeast proteome pair that underwent a whole genome duplication. The feature selection study showed that alignment-based features were top-ranked for the best classifiers while the runners-up were

  10. Biaxial magnetic grain alignment

    International Nuclear Information System (INIS)

    Staines, M.; Genoud, J.-Y.; Mawdsley, A.; Manojlovic, V.

    2000-01-01

    Full text: We describe a dynamic magnetic grain alignment technique which can be used to produce YBCO thick films with a high degree of biaxial texture. The technique is, however, generally applicable to preparing ceramics or composite materials from granular materials with orthorhombic or lower crystal symmetry and is therefore not restricted to superconducting applications. Because magnetic alignment is a bulk effect, textured substrates are not required, unlike epitaxial coated tape processes such as RABiTS. We have used the technique to produce thick films of Y-247 on untextured silver substrates. After processing to Y-123 the films show a clear enhancement of critical current density relative to identically prepared untextured or uniaxially textured samples. We describe procedures for preparing materials using magnetic biaxial grain alignment with the emphasis on alignment in epoxy, which can give extremely high texture. X-ray rocking curves with FWHM of as little as 1-2 degrees have been measured

  11. CAMPways: constrained alignment framework for the comparative analysis of a pair of metabolic pathways.

    Science.gov (United States)

    Abaka, Gamze; Bıyıkoğlu, Türker; Erten, Cesim

    2013-07-01

    Given a pair of metabolic pathways, an alignment of the pathways corresponds to a mapping between similar substructures of the pair. Successful alignments may provide useful applications in phylogenetic tree reconstruction, drug design and overall may enhance our understanding of cellular metabolism. We consider the problem of providing one-to-many alignments of reactions in a pair of metabolic pathways. We first provide a constrained alignment framework applicable to the problem. We show that the constrained alignment problem even in a primitive setting is computationally intractable, which justifies efforts for designing efficient heuristics. We present our Constrained Alignment of Metabolic Pathways (CAMPways) algorithm designed for this purpose. Through extensive experiments involving a large pathway database, we demonstrate that when compared with a state-of-the-art alternative, the CAMPways algorithm provides better alignment results on metabolic networks as far as measures based on same-pathway inclusion and biochemical significance are concerned. The execution speed of our algorithm constitutes yet another important improvement over alternative algorithms. Open source codes, executable binary, useful scripts, all the experimental data and the results are freely available as part of the Supplementary Material at http://code.google.com/p/campways/. Supplementary data are available at Bioinformatics online.

  12. Magnetic field-aligned particle precipitation

    International Nuclear Information System (INIS)

    Carlson, W.

    1985-01-01

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

  13. XRD alignment, calibration and performance

    International Nuclear Information System (INIS)

    Davy, L.

    2002-01-01

    Full text: The quality of any diffractometer system is very much dependent on the alignment, calibration and performance. The three subjects are very much related. Firstly, you must know how to carry out the full diffractometer alignment. XRD alignment is easy once you know how. The presentation will show you step by step to carry out the full alignment. Secondly, you need to know how to calibrate the diffractometer system. The presentation will show you how to calibrate the goniometer, detector etc. Thirdly, to prove the system is working within the manufacturer specification. The presentation will show you how to carry out the resolution, reproducibility and linearity test. Copyright (2002) Australian X-ray Analytical Association Inc

  14. Sales Territory Alignment: A Review and Model

    OpenAIRE

    Andris A. Zoltners; Prabhakant Sinha

    1983-01-01

    The sales territory alignment problem may be viewed as the problem of grouping small geographic sales coverage units into larger geographic clusters called sales territories in a way that the sales territories are acceptable according to managerially relevant alignment criteria. This paper first reviews sales territory alignment models which have appeared in the marketing literature. A framework for sales territory alignment and several properties of a good sales territory alignment are devel...

  15. SU-E-J-33: Comparison Between Soft Tissue Alignment and Bony Alignment for Pancreatic Cancer Radiotherapy

    Energy Technology Data Exchange (ETDEWEB)

    Suh, Y; Crane, C; Krishnan, S; Das, P; Koay, E; Beddar, S [UT MD Anderson Cancer Center, Houston, TX (United States)

    2015-06-15

    Purpose An IGRT modality for pancreatic cancer treatment with dose escalation at our institution is in-room daily CT imaging. The purpose of this study is to assess the difference between soft tissue alignment and bony alignment for pancreatic tumor localization. Methods Eighteen patients with pancreatic tumors who underwent IMRT treatment with an inspiration breath-hold technique between July 2012 and February 2015 are included in this study. Prior to each treatment, a CT scan was acquired. The CT image guidance started with auto-alignment to either the bony anatomy (vertebral bodies) or fiducials (for the six patients with the stent in/near the tumor) and then, when necessary, manual adjustments were made based on soft tissue alignment using clinical software (CT-Assisted Targeting system). The difference between soft tissue alignment and bony/fiducial alignment was evaluated. Results Of all 380 treatments, manual adjustment was made in 225 treatments, ranging from 11% (3 treatments out of 28) to 96% (27 treatments out of 28) per patient. The mean of the difference between soft tissue alignment and bony/fiducial alignment per patient ranged from −3.6 to 0.3 mm, −1.5 to 2.8 mm, and −3.3 to 3.4 mm in the AP, SI, and RL directions, respectively. The maximum difference over all treatments was −9.5, −14.6, and −14.6 mm in the AP, SI, and RL directions, respectively. Conclusion About 60% of the time, manual adjustment based on soft tissue alignment was required. The extent of manual adjustment was usually small but varied significantly from patient to patient. The ultimate goal of the IGRT modality using daily CT imaging is not to fully cover the target but to spare organs-at-risk as much as possible to avoid them moving into higher dose gradients than accepted in the treatment plan. To this end, manual adjustment based on soft tissue alignment is critically important.

  16. A putative peroxidase cDNA from turnip and analysis of the encoded protein sequence.

    Science.gov (United States)

    Romero-Gómez, S; Duarte-Vázquez, M A; García-Almendárez, B E; Mayorga-Martínez, L; Cervantes-Avilés, O; Regalado, C

    2008-12-01

    A putative peroxidase cDNA was isolated from turnip roots (Brassica napus L. var. purple top white globe) by reverse transcriptase-polymerase chain reaction (RT-PCR) and rapid amplification of cDNA ends (RACE). Total RNA extracted from mature turnip roots was used as a template for RT-PCR, using a degenerated primer designed to amplify the highly conserved distal motif of plant peroxidases. The resulting partial sequence was used to design the rest of the specific primers for 5' and 3' RACE. Two cDNA fragments were purified, sequenced, and aligned with the partial sequence from RT-PCR, and a complete overlapping sequence was obtained and labeled as BbPA (Genbank Accession No. AY423440, named as podC). The full length cDNA is 1167bp long and contains a 1077bp open reading frame (ORF) encoding a 358 deduced amino acid peroxidase polypeptide. The putative peroxidase (BnPA) showed a calculated Mr of 34kDa, and isoelectric point (pI) of 4.5, with no significant identity with other reported turnip peroxidases. Sequence alignment showed that only three peroxidases have a significant identity with BnPA namely AtP29a (84%), and AtPA2 (81%) from Arabidopsis thaliana, and HRPA2 (82%) from horseradish (Armoracia rusticana). Work is in progress to clone this gene into an adequate host to study the specific role and possible biotechnological applications of this alternative peroxidase source.

  17. Incorporation of unique molecular identifiers in TruSeq adapters improves the accuracy of quantitative sequencing.

    Science.gov (United States)

    Hong, Jungeui; Gresham, David

    2017-11-01

    Quantitative analysis of next-generation sequencing (NGS) data requires discriminating duplicate reads generated by PCR from identical molecules that are of unique origin. Typically, PCR duplicates are identified as sequence reads that align to the same genomic coordinates using reference-based alignment. However, identical molecules can be independently generated during library preparation. Misidentification of these molecules as PCR duplicates can introduce unforeseen biases during analyses. Here, we developed a cost-effective sequencing adapter design by modifying Illumina TruSeq adapters to incorporate a unique molecular identifier (UMI) while maintaining the capacity to undertake multiplexed, single-index sequencing. Incorporation of UMIs into TruSeq adapters (TrUMIseq adapters) enables identification of bona fide PCR duplicates as identically mapped reads with identical UMIs. Using TrUMIseq adapters, we show that accurate removal of PCR duplicates results in improved accuracy of both allele frequency (AF) estimation in heterogeneous populations using DNA sequencing and gene expression quantification using RNA-Seq.

  18. Optimization of HPV DNA detection in urine by improving collection, storage, and extraction.

    Science.gov (United States)

    Vorsters, A; Van den Bergh, J; Micalessi, I; Biesmans, S; Bogers, J; Hens, A; De Coster, I; Ieven, M; Van Damme, P

    2014-11-01

    The benefits of using urine for the detection of human papillomavirus (HPV) DNA have been evaluated in disease surveillance, epidemiological studies, and screening for cervical cancers in specific subgroups. HPV DNA testing in urine is being considered for important purposes, notably the monitoring of HPV vaccination in adolescent girls and young women who do not wish to have a vaginal examination. The need to optimize and standardize sampling, storage, and processing has been reported.In this paper, we examined the impact of a DNA-conservation buffer, the extraction method, and urine sampling on the detection of HPV DNA and human DNA in urine provided by 44 women with a cytologically normal but HPV DNA-positive cervical sample. Ten women provided first-void and midstream urine samples. DNA analysis was performed using real-time PCR to allow quantification of HPV and human DNA.The results showed that an optimized method for HPV DNA detection in urine should (a) prevent DNA degradation during extraction and storage, (b) recover cell-free HPV DNA in addition to cell-associated DNA, (c) process a sufficient volume of urine, and (d) use a first-void sample.In addition, we found that detectable human DNA in urine may not be a good internal control for sample validity. HPV prevalence data that are based on urine samples collected, stored, and/or processed under suboptimal conditions may underestimate infection rates.

  19. A single portion of blueberry (Vaccinium corymbosum L) improves protection against DNA damage but not vascular function in healthy male volunteers.

    Science.gov (United States)

    Del Bó, Cristian; Riso, Patrizia; Campolo, Jonica; Møller, Peter; Loft, Steffen; Klimis-Zacas, Dorothy; Brambilla, Ada; Rizzolo, Anna; Porrini, Marisa

    2013-03-01

    It has been suggested that anthocyanin-rich foods may exert antioxidant effects and improve vascular function as demonstrated mainly in vitro and in the animal model. Blueberries are rich sources of anthocyanins and we hypothesized that their intake could improve cell protection against oxidative stress and affect endothelial function in humans. The aim of the study was to investigate the effect of one portion (300 g) of blueberries on selected markers of oxidative stress and antioxidant protection (endogenous and oxidatively induced DNA damage) and of vascular function (changes in peripheral arterial tone and plasma nitric oxide levels) in male subjects. In a randomized cross-over design, separated by a wash out period ten young volunteers received one portion of blueberries ground by blender or one portion of a control jelly. Before and after consumption (at 1, 2, and 24 hours), blood samples were collected and used to evaluate anthocyanin absorption (through mass spectrometry), endogenous and H(2)O(2)-induced DNA damage in blood mononuclear cells (through the comet assay), and plasma nitric oxide concentrations (through a fluorometric assay). Peripheral arterial function was assessed by means of Endo-PAT 2000. Blueberries significantly reduced (P < .01) H(2)O(2)-induced DNA damage (-18%) 1 hour after blueberry consumption compared to control. No significant differences were observed for endogenous DNA damage, peripheral arterial function and nitric oxide levels after blueberry intake. In conclusion, one portion of blueberries seems sufficient to improve cell antioxidant defense against DNA damage, but further studies are necessary to understand their role on vascular function. Copyright © 2013 Elsevier Inc. All rights reserved.

  20. An improved method of DNA extraction from plants for pathogen ...

    African Journals Online (AJOL)

    Polymerase chain reaction (PCR)-based applications in plant molecular biology and molecular diagnostics for plant pathogens require good quality DNA for reliable and reproducible results. Leaf tissue is often the choice for DNA extraction, but the use of other sources such as tubers, stems, or seeds, is not uncommon.