WorldWideScience

Sample records for neighbor-joining tree based

  1. Recrafting the neighbor-joining method

    Directory of Open Access Journals (Sweden)

    Pedersen Christian NS

    2006-01-01

    Full Text Available Abstract Background The neighbor-joining method by Saitou and Nei is a widely used method for constructing phylogenetic trees. The formulation of the method gives rise to a canonical Θ(n3 algorithm upon which all existing implementations are based. Results In this paper we present techniques for speeding up the canonical neighbor-joining method. Our algorithms construct the same phylogenetic trees as the canonical neighbor-joining method. The best-case running time of our algorithms are O(n2 but the worst-case remains O(n3. We empirically evaluate the performance of our algoritms on distance matrices obtained from the Pfam collection of alignments. The experiments indicate that the running time of our algorithms evolve as Θ(n2 on the examined instance collection. We also compare the running time with that of the QuickTree tool, a widely used efficient implementation of the canonical neighbor-joining method. Conclusion The experiments show that our algorithms also yield a significant speed-up, already for medium sized instances.

  2. Recrafting the Neighbor-Joining Method

    DEFF Research Database (Denmark)

    Mailund; Brodal, Gerth Stølting; Fagerberg, Rolf

    2006-01-01

    Background: The neighbor-joining method by Saitou and Nei is a widely used method for constructing phylogenetic trees. The formulation of the method gives rise to a canonical Θ(n3) algorithm upon which all existing implementations are based. Methods: In this paper we present techniques for speeding...... up the canonical neighbor-joining method. Our algorithms construct the same phylogenetic trees as the canonical neighbor-joining method. The best-case running time of our algorithms are O(n2) but the worst-case remains O(n3). We empirically evaluate the performance of our algoritms on distance...... matrices obtained from the Pfam collection of alignments. Results: The experiments indicate that the running time of our algorithms evolve as Θ(n2) on the examined instance collection. We also compare the running time with that of the QuickTree tool, a widely used efficient implementation of the canonical...

  3. Speeding Up Neighbour-Joining Tree Construction

    DEFF Research Database (Denmark)

    Brodal, Gerth Stølting; Fagerberg, Rolf; Mailund, Thomas

    A widely used method for constructing phylogenetic trees is the neighbour-joining method of Saitou and Nei. We develope heuristics for speeding up the neighbour-joining method which generate the same phylogenetic trees as the original method. All heuristics are based on using a quad-tree to guide...... the search for the next pair of nodes to join, but di#er in the information stored in quad-tree nodes, the way the search is performed, and in the way the quad-tree is updated after a join. We empirically evaluate the performance of the heuristics on distance matrices obtained from the Pfam collection...... of alignments, and compare the running time with that of the QuickTree tool, a well-known and widely used implementation of the standard neighbour-joining method. The results show that the presented heuristics can give a significant speed-up over the standard neighbour-joining method, already for medium sized...

  4. QuickJoin—Fast Neighbour-Joining Tree Reconstruction

    DEFF Research Database (Denmark)

    Mailund; Pedersen, Christian N. Storm

    2004-01-01

    We have built a tool for fast construction of very large phylogenetic trees. The tool uses heuristics for speeding up the neighbour-joining algorithm—while still constructing the same tree as the original neighbour-joining algorithm—making it possible to construct trees for ~8000 species in less...

  5. Fast Tree: Computing Large Minimum-Evolution Trees with Profiles instead of a Distance Matrix

    OpenAIRE

    N. Price, Morgan

    2009-01-01

    Gene families are growing rapidly, but standard methods for inferring phylogenies do not scale to alignments with over 10,000 sequences. We present FastTree, a method for constructing large phylogenies and for estimating their reliability. Instead of storing a distance matrix, FastTree stores sequence profiles of internal nodes in the tree. FastTree uses these profiles to implement neighbor-joining and uses heuristics to quickly identify candidate joins. FastTree then uses nearest-neighbor i...

  6. FastTree: Computing Large Minimum Evolution Trees with Profiles instead of a Distance Matrix

    OpenAIRE

    Price, Morgan N.; Dehal, Paramvir S.; Arkin, Adam P.

    2009-01-01

    Gene families are growing rapidly, but standard methods for inferring phylogenies do not scale to alignments with over 10,000 sequences. We present FastTree, a method for constructing large phylogenies and for estimating their reliability. Instead of storing a distance matrix, FastTree stores sequence profiles of internal nodes in the tree. FastTree uses these profiles to implement Neighbor-Joining and uses heuristics to quickly identify candidate joins. FastTree then uses nearest neighbor in...

  7. Distance-Based Phylogenetic Methods Around a Polytomy.

    Science.gov (United States)

    Davidson, Ruth; Sullivant, Seth

    2014-01-01

    Distance-based phylogenetic algorithms attempt to solve the NP-hard least-squares phylogeny problem by mapping an arbitrary dissimilarity map representing biological data to a tree metric. The set of all dissimilarity maps is a Euclidean space properly containing the space of all tree metrics as a polyhedral fan. Outputs of distance-based tree reconstruction algorithms such as UPGMA and neighbor-joining are points in the maximal cones in the fan. Tree metrics with polytomies lie at the intersections of maximal cones. A phylogenetic algorithm divides the space of all dissimilarity maps into regions based upon which combinatorial tree is reconstructed by the algorithm. Comparison of phylogenetic methods can be done by comparing the geometry of these regions. We use polyhedral geometry to compare the local nature of the subdivisions induced by least-squares phylogeny, UPGMA, and neighbor-joining when the true tree has a single polytomy with exactly four neighbors. Our results suggest that in some circumstances, UPGMA and neighbor-joining poorly match least-squares phylogeny.

  8. Fast Tree: Computing Large Minimum-Evolution Trees with Profiles instead of a Distance Matrix

    Energy Technology Data Exchange (ETDEWEB)

    N. Price, Morgan; S. Dehal, Paramvir; P. Arkin, Adam

    2009-07-31

    Gene families are growing rapidly, but standard methods for inferring phylogenies do not scale to alignments with over 10,000 sequences. We present FastTree, a method for constructing large phylogenies and for estimating their reliability. Instead of storing a distance matrix, FastTree stores sequence profiles of internal nodes in the tree. FastTree uses these profiles to implement neighbor-joining and uses heuristics to quickly identify candidate joins. FastTree then uses nearest-neighbor interchanges to reduce the length of the tree. For an alignment with N sequences, L sites, and a different characters, a distance matrix requires O(N^2) space and O(N^2 L) time, but FastTree requires just O( NLa + N sqrt(N) ) memory and O( N sqrt(N) log(N) L a ) time. To estimate the tree's reliability, FastTree uses local bootstrapping, which gives another 100-fold speedup over a distance matrix. For example, FastTree computed a tree and support values for 158,022 distinct 16S ribosomal RNAs in 17 hours and 2.4 gigabytes of memory. Just computing pairwise Jukes-Cantor distances and storing them, without inferring a tree or bootstrapping, would require 17 hours and 50 gigabytes of memory. In simulations, FastTree was slightly more accurate than neighbor joining, BIONJ, or FastME; on genuine alignments, FastTree's topologies had higher likelihoods. FastTree is available at http://microbesonline.org/fasttree.

  9. Load Balancing Issues with Constructing Phylogenetic Trees using Neighbour-Joining Algorithm

    International Nuclear Information System (INIS)

    Al Mamun, S M

    2012-01-01

    Phylogenetic tree construction is one of the most important and interesting problems in bioinformatics. Constructing an efficient phylogenetic tree has always been a research issue. It needs to consider both the correctness and the speed of the tree construction. In this paper, we implemented the neighbour-joining algorithm, using Message Passing Interface (MPI) for constructing the phylogenetic tree. Performance is efficacious, comparing to the best sequential algorithm. From this paper, it would be clear to the researchers that how load balance can make a great effect for constructing phylogenetic trees using neighbour-joining algorithm.

  10. Local biotic adaptation of trees and shrubs to plant neighbors

    Science.gov (United States)

    Grady, Kevin C.; Wood, Troy E.; Kolb, Thomas E.; Hersch-Green, Erika; Shuster, Stephen M.; Gehring, Catherine A.; Hart, Stephen C.; Allan, Gerard J.; Whitham, Thomas G.

    2017-01-01

    Natural selection as a result of plant–plant interactions can lead to local biotic adaptation. This may occur where species frequently interact and compete intensely for resources limiting growth, survival, and reproduction. Selection is demonstrated by comparing a genotype interacting with con- or hetero-specific sympatric neighbor genotypes with a shared site-level history (derived from the same source location), to the same genotype interacting with foreign neighbor genotypes (from different sources). Better genotype performance in sympatric than allopatric neighborhoods provides evidence of local biotic adaptation. This pattern might be explained by selection to avoid competition by shifting resource niches (differentiation) or by interactions benefitting one or more members (facilitation). We tested for local biotic adaptation among two riparian trees, Populus fremontii and Salix gooddingii, and the shrub Salix exigua by transplanting replicated genotypes from multiple source locations to a 17 000 tree common garden with sympatric and allopatric treatments along the Colorado River in California. Three major patterns were observed: 1) across species, 62 of 88 genotypes grew faster with sympatric neighbors than allopatric neighbors; 2) these growth rates, on an individual tree basis, were 44, 15 and 33% higher in sympatric than allopatric treatments for P. fremontii, S. exigua and S. gooddingii, respectively, and; 3) survivorship was higher in sympatric treatments for P. fremontiiand S. exigua. These results support the view that fitness of foundation species supporting diverse communities and dominating ecosystem processes is determined by adaptive interactions among multiple plant species with the outcome that performance depends on the genetic identity of plant neighbors. The occurrence of evolution in a plant-community context for trees and shrubs builds on ecological evolutionary research that has demonstrated co-evolution among herbaceous taxa, and

  11. Genetic distances and phylogenetic trees of different Awassi sheep populations based on DNA sequencing.

    Science.gov (United States)

    Al-Atiyat, R M; Aljumaah, R S

    2014-08-27

    This study aimed to estimate evolutionary distances and to reconstruct phylogeny trees between different Awassi sheep populations. Thirty-two sheep individuals from three different geographical areas of Jordan and the Kingdom of Saudi Arabia (KSA) were randomly sampled. DNA was extracted from the tissue samples and sequenced using the T7 promoter universal primer. Different phylogenetic trees were reconstructed from 0.64-kb DNA sequences using the MEGA software with the best general time reverse distance model. Three methods of distance estimation were then used. The maximum composite likelihood test was considered for reconstructing maximum likelihood, neighbor-joining and UPGMA trees. The maximum likelihood tree indicated three major clusters separated by cytosine (C) and thymine (T). The greatest distance was shown between the South sheep and North sheep. On the other hand, the KSA sheep as an outgroup showed shorter evolutionary distance to the North sheep population than to the others. The neighbor-joining and UPGMA trees showed quite reliable clusters of evolutionary differentiation of Jordan sheep populations from the Saudi population. The overall results support geographical information and ecological types of the sheep populations studied. Summing up, the resulting phylogeny trees may contribute to the limited information about the genetic relatedness and phylogeny of Awassi sheep in nearby Arab countries.

  12. Enumeration for spanning trees and forests of join graphs based on the combinatorial decomposition

    Directory of Open Access Journals (Sweden)

    Sung Sik U

    2016-10-01

    Full Text Available This paper discusses the enumeration for rooted spanning trees and forests of the labelled join graphs $K_m+H_n$ and $K_m+K_{n,p}$, where $H_n$ is a graph with $n$ isolated vertices. 

  13. Neighboring trees affect ectomycorrhizal fungal community composition in a woodland-forest ecotone.

    Science.gov (United States)

    Hubert, Nathaniel A; Gehring, Catherine A

    2008-09-01

    Ectomycorrhizal fungi (EMF) are frequently species rich and functionally diverse; yet, our knowledge of the environmental factors that influence local EMF diversity and species composition remains poor. In particular, little is known about the influence of neighboring plants on EMF community structure. We tested the hypothesis that the EMF of plants with heterospecific neighbors would differ in species richness and community composition from the EMF of plants with conspecific neighbors. We conducted our study at the ecotone between pinyon (Pinus edulis)-juniper (Juniperus monosperma) woodland and ponderosa pine (Pinus ponderosa) forest in northern Arizona, USA where the dominant trees formed associations with either EMF (P. edulis and P. ponderosa) or arbuscular mycorrhizal fungi (AMF; J. monosperma). We also compared the EMF communities of pinyon and ponderosa pines where their rhizospheres overlapped. The EMF community composition, but not species richness of pinyon pines was significantly influenced by neighboring AM juniper, but not by neighboring EM ponderosa pine. Ponderosa pine EMF communities were different in species composition when growing in association with pinyon pine than when growing in association with a conspecific. The EMF communities of pinyon and ponderosa pines were similar where their rhizospheres overlapped consisting of primarily the same species in similar relative abundance. Our findings suggest that neighboring tree species identity shaped EMF community structure, but that these effects were specific to host-neighbor combinations. The overlap in community composition between pinyon pine and ponderosa pine suggests that these tree species may serve as reservoirs of EMF inoculum for one another.

  14. A γ dose distribution evaluation technique using the k-d tree for nearest neighbor searching

    International Nuclear Information System (INIS)

    Yuan Jiankui; Chen Weimin

    2010-01-01

    Purpose: The authors propose an algorithm based on the k-d tree for nearest neighbor searching to improve the γ calculation time for 2D and 3D dose distributions. Methods: The γ calculation method has been widely used for comparisons of dose distributions in clinical treatment plans and quality assurances. By specifying the acceptable dose and distance-to-agreement criteria, the method provides quantitative measurement of the agreement between the reference and evaluation dose distributions. The γ value indicates the acceptability. In regions where γ≤1, the predefined criterion is satisfied and thus the agreement is acceptable; otherwise, the agreement fails. Although the concept of the method is not complicated and a quick naieve implementation is straightforward, an efficient and robust implementation is not trivial. Recent algorithms based on exhaustive searching within a maximum radius, the geometric Euclidean distance, and the table lookup method have been proposed to improve the computational time for multidimensional dose distributions. Motivated by the fact that the least searching time for finding a nearest neighbor can be an O(log N) operation with a k-d tree, where N is the total number of the dose points, the authors propose an algorithm based on the k-d tree for the γ evaluation in this work. Results: In the experiment, the authors found that the average k-d tree construction time per reference point is O(log N), while the nearest neighbor searching time per evaluation point is proportional to O(N 1/k ), where k is between 2 and 3 for two-dimensional and three-dimensional dose distributions, respectively. Conclusions: Comparing with other algorithms such as exhaustive search and sorted list O(N), the k-d tree algorithm for γ evaluation is much more efficient.

  15. Computing Refined Buneman Trees in Cubic Time

    DEFF Research Database (Denmark)

    Brodal, G.S.; Fagerberg, R.; Östlin, A.

    2003-01-01

    Reconstructing the evolutionary tree for a set of n species based on pairwise distances between the species is a fundamental problem in bioinformatics. Neighbor joining is a popular distance based tree reconstruction method. It always proposes fully resolved binary trees despite missing evidence...... in the underlying distance data. Distance based methods based on the theory of Buneman trees and refined Buneman trees avoid this problem by only proposing evolutionary trees whose edges satisfy a number of constraints. These trees might not be fully resolved but there is strong combinatorial evidence for each...... proposed edge. The currently best algorithm for computing the refined Buneman tree from a given distance measure has a running time of O(n 5) and a space consumption of O(n 4). In this paper, we present an algorithm with running time O(n 3) and space consumption O(n 2). The improved complexity of our...

  16. Fast and scalable inequality joins

    KAUST Repository

    Khayyat, Zuhair

    2016-09-07

    Inequality joins, which is to join relations with inequality conditions, are used in various applications. Optimizing joins has been the subject of intensive research ranging from efficient join algorithms such as sort-merge join, to the use of efficient indices such as (Formula presented.)-tree, (Formula presented.)-tree and Bitmap. However, inequality joins have received little attention and queries containing such joins are notably very slow. In this paper, we introduce fast inequality join algorithms based on sorted arrays and space-efficient bit-arrays. We further introduce a simple method to estimate the selectivity of inequality joins which is then used to optimize multiple predicate queries and multi-way joins. Moreover, we study an incremental inequality join algorithm to handle scenarios where data keeps changing. We have implemented a centralized version of these algorithms on top of PostgreSQL, a distributed version on top of Spark SQL, and an existing data cleaning system, Nadeef. By comparing our algorithms against well-known optimization techniques for inequality joins, we show our solution is more scalable and several orders of magnitude faster. © 2016 Springer-Verlag Berlin Heidelberg

  17. An Approach to Indexing and Retrieval of Spatial Data with Reduced R+ Tree and K-NN Query Algorithm

    OpenAIRE

    S. Palaniappan; T.V. Rajinikanth; A. Govardhan

    2015-01-01

    Recently, “spatial data bases have been extensively adopted in the recent decade and various methods have been presented to store, browse, search and retrieve spatial objects”. In this study, a method is plotted for retrieving nearest neighbors from spatial data indexed by R+ tree. The approach uses a reduced R+tree for the purpose of representing the spatial data. Initially the spatial data is selected and R+tree is constructed accordingly. Then a function called joining nodes is applied to ...

  18. THE USE OF INTER SIMPLE SEQUENCE REPEATS (ISSR) IN DISTINGUISHING NEIGHBORING DOUGLAS-FIR TREES AS A MEANS TO IDENTIFYING TREE ROOTS WITH ABOVE-GROUND BIOMASS

    Science.gov (United States)

    We are attempting to identify specific root fragments from soil cores with individual trees. We successfully used Inter Simple Sequence Repeats (ISSR) to distinguish neighboring old-growth Douglas-fir trees from one another, while maintaining identity among each tree's parts. W...

  19. constNJ: an algorithm to reconstruct sets of phylogenetic trees satisfying pairwise topological constraints.

    Science.gov (United States)

    Matsen, Frederick A

    2010-06-01

    This article introduces constNJ (constrained neighbor-joining), an algorithm for phylogenetic reconstruction of sets of trees with constrained pairwise rooted subtree-prune-regraft (rSPR) distance. We are motivated by the problem of constructing sets of trees that must fit into a recombination, hybridization, or similar network. Rather than first finding a set of trees that are optimal according to a phylogenetic criterion (e.g., likelihood or parsimony) and then attempting to fit them into a network, constNJ estimates the trees while enforcing specified rSPR distance constraints. The primary input for constNJ is a collection of distance matrices derived from sequence blocks which are assumed to have evolved in a tree-like manner, such as blocks of an alignment which do not contain any recombination breakpoints. The other input is a set of rSPR constraint inequalities for any set of pairs of trees. constNJ is consistent and a strict generalization of the neighbor-joining algorithm; it uses the new notion of maximum agreement partitions (MAPs) to assure that the resulting trees satisfy the given rSPR distance constraints.

  20. Sequence comparison alignment-free approach based on suffix tree and L-words frequency.

    Science.gov (United States)

    Soares, Inês; Goios, Ana; Amorim, António

    2012-01-01

    The vast majority of methods available for sequence comparison rely on a first sequence alignment step, which requires a number of assumptions on evolutionary history and is sometimes very difficult or impossible to perform due to the abundance of gaps (insertions/deletions). In such cases, an alternative alignment-free method would prove valuable. Our method starts by a computation of a generalized suffix tree of all sequences, which is completed in linear time. Using this tree, the frequency of all possible words with a preset length L-L-words--in each sequence is rapidly calculated. Based on the L-words frequency profile of each sequence, a pairwise standard Euclidean distance is then computed producing a symmetric genetic distance matrix, which can be used to generate a neighbor joining dendrogram or a multidimensional scaling graph. We present an improvement to word counting alignment-free approaches for sequence comparison, by determining a single optimal word length and combining suffix tree structures to the word counting tasks. Our approach is, thus, a fast and simple application that proved to be efficient and powerful when applied to mitochondrial genomes. The algorithm was implemented in Python language and is freely available on the web.

  1. Estimating cavity tree and snag abundance using negative binomial regression models and nearest neighbor imputation methods

    Science.gov (United States)

    Bianca N.I. Eskelson; Hailemariam Temesgen; Tara M. Barrett

    2009-01-01

    Cavity tree and snag abundance data are highly variable and contain many zero observations. We predict cavity tree and snag abundance from variables that are readily available from forest cover maps or remotely sensed data using negative binomial (NB), zero-inflated NB, and zero-altered NB (ZANB) regression models as well as nearest neighbor (NN) imputation methods....

  2. Accurate and robust phylogeny estimation based on profile distances: a study of the Chlorophyceae (Chlorophyta

    Directory of Open Access Journals (Sweden)

    Rahmann Sven

    2004-06-01

    Full Text Available Abstract Background In phylogenetic analysis we face the problem that several subclade topologies are known or easily inferred and well supported by bootstrap analysis, but basal branching patterns cannot be unambiguously estimated by the usual methods (maximum parsimony (MP, neighbor-joining (NJ, or maximum likelihood (ML, nor are they well supported. We represent each subclade by a sequence profile and estimate evolutionary distances between profiles to obtain a matrix of distances between subclades. Results Our estimator of profile distances generalizes the maximum likelihood estimator of sequence distances. The basal branching pattern can be estimated by any distance-based method, such as neighbor-joining. Our method (profile neighbor-joining, PNJ then inherits the accuracy and robustness of profiles and the time efficiency of neighbor-joining. Conclusions Phylogenetic analysis of Chlorophyceae with traditional methods (MP, NJ, ML and MrBayes reveals seven well supported subclades, but the methods disagree on the basal branching pattern. The tree reconstructed by our method is better supported and can be confirmed by known morphological characters. Moreover the accuracy is significantly improved as shown by parametric bootstrap.

  3. Sequence Comparison Alignment-Free Approach Based on Suffix Tree and L-Words Frequency

    Directory of Open Access Journals (Sweden)

    Inês Soares

    2012-01-01

    Full Text Available The vast majority of methods available for sequence comparison rely on a first sequence alignment step, which requires a number of assumptions on evolutionary history and is sometimes very difficult or impossible to perform due to the abundance of gaps (insertions/deletions. In such cases, an alternative alignment-free method would prove valuable. Our method starts by a computation of a generalized suffix tree of all sequences, which is completed in linear time. Using this tree, the frequency of all possible words with a preset length L—L-words—in each sequence is rapidly calculated. Based on the L-words frequency profile of each sequence, a pairwise standard Euclidean distance is then computed producing a symmetric genetic distance matrix, which can be used to generate a neighbor joining dendrogram or a multidimensional scaling graph. We present an improvement to word counting alignment-free approaches for sequence comparison, by determining a single optimal word length and combining suffix tree structures to the word counting tasks. Our approach is, thus, a fast and simple application that proved to be efficient and powerful when applied to mitochondrial genomes. The algorithm was implemented in Python language and is freely available on the web.

  4. Next neighbors effect along the Ca-Sr-Ba-åkermanite join: Long-range vs. short-range structural features

    Science.gov (United States)

    Dondi, Michele; Ardit, Matteo; Cruciani, Giuseppe

    2013-06-01

    An original approach has been developed herein to explore the correlations between short- and long-range structural properties of solid solutions. X-ray diffraction (XRD) and electronic absorption spectroscopy (EAS) data were combined on a (Ca,Sr,Ba)2(Mg0.7Co0.3)Si2O7 join to determine average and local distances, respectively. Instead of varying the EAS-active ion concentration along the join, as has commonly been performed in previous studies, the constant replacement of Mg2+ by a minimal fraction of a similar size cation (Co2+) has been used to assess the effects of varying second-nearest neighbor cations (Ca, Sr, Ba) on the local distances of the first shell. A comparison between doped and un-doped series has shown that, although the overall symmetry of the Co-centered T1-site was retained, greater relaxation occurs at the CoO4 tetrahedra which become increasingly large and more distorted than the MgO4 tetrahedra. This is indicated by an increase in both the quadratic elongation (λT1) and the bond angle variance (σ2T1) distortion indices, as the whole structure expands due to an increase in size in the second-nearest neighbors. This behavior highlights the effect of the different electronic configurations of Co2+ (3d7) and Mg2+ (2p6) in spite of their very similar ionic size. Furthermore, although the overall symmetry of the Co-centered T1-site is retained, relatively limited (Co2+-O occur along the solid solution series and large changes are found in molar absorption coefficients showing that EAS Co2+-bands are highly sensitive to change in the local structure.

  5. Lightning Fast and Space Efficient Inequality Joins

    KAUST Repository

    Khayyat, Zuhair

    2015-09-01

    Inequality joins, which join relational tables on inequality conditions, are used in various applications. While there have been a wide range of optimization methods for joins in database systems, from algorithms such as sort-merge join and band join, to various indices such as B+-tree,R*-tree and Bitmap, inequality joins have received little attention and queries containing such joins are usually very slow. In this paper, we introduce fast inequality join algorithms. We put columns to be joined in sorted arrays and we use permutation arrays to encode positions of tuples in one sorted array w.r.t. the other sorted array. In contrast to sort-merge join, we use space effcient bit-arrays that enable optimizations, such as Bloom filter indices, for fast computation of the join results. We have implemented a centralized version of these algorithms on top of PostgreSQL, and a distributed version on top of Spark SQL. We have compared against well known optimization techniques for inequality joins and show that our solution is more scalable and several orders of magnitude faster.

  6. Lightning fast and space efficient inequality joins

    KAUST Repository

    Khayyat, Zuhair

    2015-09-01

    Inequality joins, which join relational tables on inequality conditions, are used in various applications. While there have been a wide range of optimization methods for joins in database systems, from algorithms such as sort-merge join and band join, to various indices such as B+-tree, R*-tree and Bitmap, inequality joins have received little attention and queries containing such joins are usually very slow. In this paper, we introduce fast inequality join algorithms. We put columns to be joined in sorted arrays and we use permutation arrays to encode positions of tuples in one sorted array w.r.t. the other sorted array. In contrast to sort-merge join, we use space efficient bit-arrays that enable optimizations, such as Bloom filter indices, for fast computation of the join results. We have implemented a centralized version of these algorithms on top of PostgreSQL, and a distributed version on top of Spark SQL. We have compared against well known optimization techniques for inequality joins and show that our solution is more scalable and several orders of magnitude faster.

  7. Lightning fast and space efficient inequality joins

    KAUST Repository

    Khayyat, Zuhair; Lucia, William; Singh, Meghna; Ouzzani, Mourad; Papotti, Paolo; Quiané -Ruiz, Jorge-Arnulfo; Tang, Nan; Kalnis, Panos

    2015-01-01

    Inequality joins, which join relational tables on inequality conditions, are used in various applications. While there have been a wide range of optimization methods for joins in database systems, from algorithms such as sort-merge join and band join, to various indices such as B+-tree, R*-tree and Bitmap, inequality joins have received little attention and queries containing such joins are usually very slow. In this paper, we introduce fast inequality join algorithms. We put columns to be joined in sorted arrays and we use permutation arrays to encode positions of tuples in one sorted array w.r.t. the other sorted array. In contrast to sort-merge join, we use space efficient bit-arrays that enable optimizations, such as Bloom filter indices, for fast computation of the join results. We have implemented a centralized version of these algorithms on top of PostgreSQL, and a distributed version on top of Spark SQL. We have compared against well known optimization techniques for inequality joins and show that our solution is more scalable and several orders of magnitude faster.

  8. A Fast Exact k-Nearest Neighbors Algorithm for High Dimensional Search Using k-Means Clustering and Triangle Inequality.

    Science.gov (United States)

    Wang, Xueyi

    2012-02-08

    The k-nearest neighbors (k-NN) algorithm is a widely used machine learning method that finds nearest neighbors of a test object in a feature space. We present a new exact k-NN algorithm called kMkNN (k-Means for k-Nearest Neighbors) that uses the k-means clustering and the triangle inequality to accelerate the searching for nearest neighbors in a high dimensional space. The kMkNN algorithm has two stages. In the buildup stage, instead of using complex tree structures such as metric trees, kd-trees, or ball-tree, kMkNN uses a simple k-means clustering method to preprocess the training dataset. In the searching stage, given a query object, kMkNN finds nearest training objects starting from the nearest cluster to the query object and uses the triangle inequality to reduce the distance calculations. Experiments show that the performance of kMkNN is surprisingly good compared to the traditional k-NN algorithm and tree-based k-NN algorithms such as kd-trees and ball-trees. On a collection of 20 datasets with up to 10(6) records and 10(4) dimensions, kMkNN shows a 2-to 80-fold reduction of distance calculations and a 2- to 60-fold speedup over the traditional k-NN algorithm for 16 datasets. Furthermore, kMkNN performs significant better than a kd-tree based k-NN algorithm for all datasets and performs better than a ball-tree based k-NN algorithm for most datasets. The results show that kMkNN is effective for searching nearest neighbors in high dimensional spaces.

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

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

  11. Tree communities of lowland warm-temperate old-growth and neighboring shelterbelt forests in the Shikoku region of southwestern Japan

    Science.gov (United States)

    Shigeo Kuramoto; Shigenori Oshioka; Takahisa Hirayama; Kaori Sato; Yasumasa Hirata

    2007-01-01

    We characterized the tree species composition of a 30 ha old-growth and neighboring shelterbelt (reserved buffer strips among conifer plantations) in warm-temperate forests in the Shikoku region of southwestern Japan. Using a two-way indicator species analysis of data from 28 plots, we identified four structural groups in terms of relative basal area. These structural...

  12. Phylogenetic trees

    OpenAIRE

    Baños, Hector; Bushek, Nathaniel; Davidson, Ruth; Gross, Elizabeth; Harris, Pamela E.; Krone, Robert; Long, Colby; Stewart, Allen; Walker, Robert

    2016-01-01

    We introduce the package PhylogeneticTrees for Macaulay2 which allows users to compute phylogenetic invariants for group-based tree models. We provide some background information on phylogenetic algebraic geometry and show how the package PhylogeneticTrees can be used to calculate a generating set for a phylogenetic ideal as well as a lower bound for its dimension. Finally, we show how methods within the package can be used to compute a generating set for the join of any two ideals.

  13. Maximum Gene-Support Tree

    Directory of Open Access Journals (Sweden)

    Yunfeng Shan

    2008-01-01

    Full Text Available Genomes and genes diversify during evolution; however, it is unclear to what extent genes still retain the relationship among species. Model species for molecular phylogenetic studies include yeasts and viruses whose genomes were sequenced as well as plants that have the fossil-supported true phylogenetic trees available. In this study, we generated single gene trees of seven yeast species as well as single gene trees of nine baculovirus species using all the orthologous genes among the species compared. Homologous genes among seven known plants were used for validation of the finding. Four algorithms—maximum parsimony (MP, minimum evolution (ME, maximum likelihood (ML, and neighbor-joining (NJ—were used. Trees were reconstructed before and after weighting the DNA and protein sequence lengths among genes. Rarely a gene can always generate the “true tree” by all the four algorithms. However, the most frequent gene tree, termed “maximum gene-support tree” (MGS tree, or WMGS tree for the weighted one, in yeasts, baculoviruses, or plants was consistently found to be the “true tree” among the species. The results provide insights into the overall degree of divergence of orthologous genes of the genomes analyzed and suggest the following: 1 The true tree relationship among the species studied is still maintained by the largest group of orthologous genes; 2 There are usually more orthologous genes with higher similarities between genetically closer species than between genetically more distant ones; and 3 The maximum gene-support tree reflects the phylogenetic relationship among species in comparison.

  14. Phase Transition and Critical Values of a Nearest-Neighbor System with Uncountable Local State Space on Cayley Trees

    International Nuclear Information System (INIS)

    Jahnel, Benedikt; Külske, Christof; Botirov, Golibjon I.

    2014-01-01

    We consider a ferromagnetic nearest-neighbor model on a Cayley tree of degree k ⩾ 2 with uncountable local state space [0,1] where the energy function depends on a parameter θ ∊[0, 1). We show that for 0 ⩽ θ ⩽ 5 3 k the model has a unique translation-invariant Gibbs measure. If 5 3 k < θ < 1 , there is a phase transition, in particular there are three translation-invariant Gibbs measures

  15. Tree-average distances on certain phylogenetic networks have their weights uniquely determined.

    Science.gov (United States)

    Willson, Stephen J

    2012-01-01

    A phylogenetic network N has vertices corresponding to species and arcs corresponding to direct genetic inheritance from the species at the tail to the species at the head. Measurements of DNA are often made on species in the leaf set, and one seeks to infer properties of the network, possibly including the graph itself. In the case of phylogenetic trees, distances between extant species are frequently used to infer the phylogenetic trees by methods such as neighbor-joining. This paper proposes a tree-average distance for networks more general than trees. The notion requires a weight on each arc measuring the genetic change along the arc. For each displayed tree the distance between two leaves is the sum of the weights along the path joining them. At a hybrid vertex, each character is inherited from one of its parents. We will assume that for each hybrid there is a probability that the inheritance of a character is from a specified parent. Assume that the inheritance events at different hybrids are independent. Then for each displayed tree there will be a probability that the inheritance of a given character follows the tree; this probability may be interpreted as the probability of the tree. The tree-average distance between the leaves is defined to be the expected value of their distance in the displayed trees. For a class of rooted networks that includes rooted trees, it is shown that the weights and the probabilities at each hybrid vertex can be calculated given the network and the tree-average distances between the leaves. Hence these weights and probabilities are uniquely determined. The hypotheses on the networks include that hybrid vertices have indegree exactly 2 and that vertices that are not leaves have a tree-child.

  16. Nearest Neighbor Search in the Metric Space of a Complex Network for Community Detection

    Directory of Open Access Journals (Sweden)

    Suman Saha

    2016-03-01

    Full Text Available The objective of this article is to bridge the gap between two important research directions: (1 nearest neighbor search, which is a fundamental computational tool for large data analysis; and (2 complex network analysis, which deals with large real graphs but is generally studied via graph theoretic analysis or spectral analysis. In this article, we have studied the nearest neighbor search problem in a complex network by the development of a suitable notion of nearness. The computation of efficient nearest neighbor search among the nodes of a complex network using the metric tree and locality sensitive hashing (LSH are also studied and experimented. For evaluation of the proposed nearest neighbor search in a complex network, we applied it to a network community detection problem. Experiments are performed to verify the usefulness of nearness measures for the complex networks, the role of metric tree and LSH to compute fast and approximate node nearness and the the efficiency of community detection using nearest neighbor search. We observed that nearest neighbor between network nodes is a very efficient tool to explore better the community structure of the real networks. Several efficient approximation schemes are very useful for large networks, which hardly made any degradation of results, whereas they save lot of computational times, and nearest neighbor based community detection approach is very competitive in terms of efficiency and time.

  17. Application of DNA Barcodes in Asian Tropical Trees--A Case Study from Xishuangbanna Nature Reserve, Southwest China.

    Science.gov (United States)

    Huang, Xiao-cui; Ci, Xiu-qin; Conran, John G; Li, Jie

    2015-01-01

    Within a regional floristic context, DNA barcoding is more useful to manage plant diversity inventories on a large scale and develop valuable conservation strategies. However, there are no DNA barcode studies from tropical areas of China, which represents one of the biodiversity hotspots around the world. A DNA barcoding database of an Asian tropical trees with high diversity was established at Xishuangbanna Nature Reserve, Yunnan, southwest China using rbcL and matK as standard barcodes, as well as trnH-psbA and ITS as supplementary barcodes. The performance of tree species identification success was assessed using 2,052 accessions from four plots belonging to two vegetation types in the region by three methods: Neighbor-Joining, Maximum-Likelihood and BLAST. We corrected morphological field identification errors (9.6%) for the three plots using rbcL and matK based on Neighbor-Joining tree. The best barcode region for PCR and sequencing was rbcL (97.6%, 90.8%), followed by trnH-psbA (93.6%, 85.6%), while matK and ITS obtained relative low PCR and sequencing success rates. However, ITS performed best for both species (44.6-58.1%) and genus (72.8-76.2%) identification. With trnH-psbA slightly less effective for species identification. The two standard barcode rbcL and matK gave poor results for species identification (24.7-28.5% and 31.6-35.3%). Compared with other studies from comparable tropical forests (e.g. Cameroon, the Amazon and India), the overall performance of the four barcodes for species identification was lower for the Xishuangbanna Nature Reserve, possibly because of species/genus ratios and species composition between these tropical areas. Although the core barcodes rbcL and matK were not suitable for species identification of tropical trees from Xishuangbanna Nature Reserve, they could still help with identification at the family and genus level. Considering the relative sequence recovery and the species identification performance, we recommend the

  18. Query and Update Efficient B+-Tree Based Indexing of Moving Objects

    DEFF Research Database (Denmark)

    Jensen, Christian Søndergaard; Lin, Dan; Ooi, Beng Chin

    2004-01-01

    . This motivates the design of a solution that enables the B+-tree to manage moving objects. We represent moving-object locations as vectors that are timestamped based on their update time. By applying a novel linearization technique to these values, it is possible to index the resulting values using a single B...... are streamed to a database. Indexes for moving objects must support queries efficiently, but must also support frequent updates. Indexes based on minimum bounding regions (MBRs) such as the R-tree exhibit high concurrency overheads during node splitting, and each individual update is known to be quite costly......+-tree that partitions values according to their timestamp and otherwise preserves spatial proximity. We develop algorithms for range and k nearest neighbor queries, as well as continuous queries. The proposal can be grafted into existing database systems cost effectively. An extensive experimental study explores...

  19. Scalable Nearest Neighbor Algorithms for High Dimensional Data.

    Science.gov (United States)

    Muja, Marius; Lowe, David G

    2014-11-01

    For many computer vision and machine learning problems, large training sets are key for good performance. However, the most computationally expensive part of many computer vision and machine learning algorithms consists of finding nearest neighbor matches to high dimensional vectors that represent the training data. We propose new algorithms for approximate nearest neighbor matching and evaluate and compare them with previous algorithms. For matching high dimensional features, we find two algorithms to be the most efficient: the randomized k-d forest and a new algorithm proposed in this paper, the priority search k-means tree. We also propose a new algorithm for matching binary features by searching multiple hierarchical clustering trees and show it outperforms methods typically used in the literature. We show that the optimal nearest neighbor algorithm and its parameters depend on the data set characteristics and describe an automated configuration procedure for finding the best algorithm to search a particular data set. In order to scale to very large data sets that would otherwise not fit in the memory of a single machine, we propose a distributed nearest neighbor matching framework that can be used with any of the algorithms described in the paper. All this research has been released as an open source library called fast library for approximate nearest neighbors (FLANN), which has been incorporated into OpenCV and is now one of the most popular libraries for nearest neighbor matching.

  20. Ubiquitous distribution of fluorescent protein in muscles of four ...

    Indian Academy of Sciences (India)

    AKI FUNAHASHI

    Phylogenetic tree of eel FPs and fish FABPs constructed by the neighbor-joining method with amino acid sequences. The bootstrap values that are based on the number per 1000 samplings are indicated in each node. The scale bar under the tree indicates. 0.05 amino acid substitutions per site. The amino acid sequences.

  1. Ant-Based Phylogenetic Reconstruction (ABPR: A new distance algorithm for phylogenetic estimation based on ant colony optimization

    Directory of Open Access Journals (Sweden)

    Karla Vittori

    2008-12-01

    Full Text Available We propose a new distance algorithm for phylogenetic estimation based on Ant Colony Optimization (ACO, named Ant-Based Phylogenetic Reconstruction (ABPR. ABPR joins two taxa iteratively based on evolutionary distance among sequences, while also accounting for the quality of the phylogenetic tree built according to the total length of the tree. Similar to optimization algorithms for phylogenetic estimation, the algorithm allows exploration of a larger set of nearly optimal solutions. We applied the algorithm to four empirical data sets of mitochondrial DNA ranging from 12 to 186 sequences, and from 898 to 16,608 base pairs, and covering taxonomic levels from populations to orders. We show that ABPR performs better than the commonly used Neighbor-Joining algorithm, except when sequences are too closely related (e.g., population-level sequences. The phylogenetic relationships recovered at and above species level by ABPR agree with conventional views. However, like other algorithms of phylogenetic estimation, the proposed algorithm failed to recover expected relationships when distances are too similar or when rates of evolution are very variable, leading to the problem of long-branch attraction. ABPR, as well as other ACO-based algorithms, is emerging as a fast and accurate alternative method of phylogenetic estimation for large data sets.

  2. Handling Neighbor Discovery and Rendezvous Consistency with Weighted Quorum-Based Approach.

    Science.gov (United States)

    Own, Chung-Ming; Meng, Zhaopeng; Liu, Kehan

    2015-09-03

    Neighbor discovery and the power of sensors play an important role in the formation of Wireless Sensor Networks (WSNs) and mobile networks. Many asynchronous protocols based on wake-up time scheduling have been proposed to enable neighbor discovery among neighboring nodes for the energy saving, especially in the difficulty of clock synchronization. However, existing researches are divided two parts with the neighbor-discovery methods, one is the quorum-based protocols and the other is co-primality based protocols. Their distinction is on the arrangements of time slots, the former uses the quorums in the matrix, the latter adopts the numerical analysis. In our study, we propose the weighted heuristic quorum system (WQS), which is based on the quorum algorithm to eliminate redundant paths of active slots. We demonstrate the specification of our system: fewer active slots are required, the referring rate is balanced, and remaining power is considered particularly when a device maintains rendezvous with discovered neighbors. The evaluation results showed that our proposed method can effectively reschedule the active slots and save the computing time of the network system.

  3. Handling Neighbor Discovery and Rendezvous Consistency with Weighted Quorum-Based Approach

    Directory of Open Access Journals (Sweden)

    Chung-Ming Own

    2015-09-01

    Full Text Available Neighbor discovery and the power of sensors play an important role in the formation of Wireless Sensor Networks (WSNs and mobile networks. Many asynchronous protocols based on wake-up time scheduling have been proposed to enable neighbor discovery among neighboring nodes for the energy saving, especially in the difficulty of clock synchronization. However, existing researches are divided two parts with the neighbor-discovery methods, one is the quorum-based protocols and the other is co-primality based protocols. Their distinction is on the arrangements of time slots, the former uses the quorums in the matrix, the latter adopts the numerical analysis. In our study, we propose the weighted heuristic quorum system (WQS, which is based on the quorum algorithm to eliminate redundant paths of active slots. We demonstrate the specification of our system: fewer active slots are required, the referring rate is balanced, and remaining power is considered particularly when a device maintains rendezvous with discovered neighbors. The evaluation results showed that our proposed method can effectively reschedule the active slots and save the computing time of the network system.

  4. A joint individual-based model coupling growth and mortality reveals that tree vigor is a key component of tropical forest dynamics.

    Science.gov (United States)

    Aubry-Kientz, Mélaine; Rossi, Vivien; Boreux, Jean-Jacques; Hérault, Bruno

    2015-06-01

    Tree vigor is often used as a covariate when tree mortality is predicted from tree growth in tropical forest dynamic models, but it is rarely explicitly accounted for in a coherent modeling framework. We quantify tree vigor at the individual tree level, based on the difference between expected and observed growth. The available methods to join nonlinear tree growth and mortality processes are not commonly used by forest ecologists so that we develop an inference methodology based on an MCMC approach, allowing us to sample the parameters of the growth and mortality model according to their posterior distribution using the joint model likelihood. We apply our framework to a set of data on the 20-year dynamics of a forest in Paracou, French Guiana, taking advantage of functional trait-based growth and mortality models already developed independently. Our results showed that growth and mortality are intimately linked and that the vigor estimator is an essential predictor of mortality, highlighting that trees growing more than expected have a far lower probability of dying. Our joint model methodology is sufficiently generic to be used to join two longitudinal and punctual linked processes and thus may be applied to a wide range of growth and mortality models. In the context of global changes, such joint models are urgently needed in tropical forests to analyze, and then predict, the effects of the ongoing changes on the tree dynamics in hyperdiverse tropical forests.

  5. Quality and efficiency in high dimensional Nearest neighbor search

    KAUST Repository

    Tao, Yufei; Yi, Ke; Sheng, Cheng; Kalnis, Panos

    2009-01-01

    Nearest neighbor (NN) search in high dimensional space is an important problem in many applications. Ideally, a practical solution (i) should be implementable in a relational database, and (ii) its query cost should grow sub-linearly with the dataset size, regardless of the data and query distributions. Despite the bulk of NN literature, no solution fulfills both requirements, except locality sensitive hashing (LSH). The existing LSH implementations are either rigorous or adhoc. Rigorous-LSH ensures good quality of query results, but requires expensive space and query cost. Although adhoc-LSH is more efficient, it abandons quality control, i.e., the neighbor it outputs can be arbitrarily bad. As a result, currently no method is able to ensure both quality and efficiency simultaneously in practice. Motivated by this, we propose a new access method called the locality sensitive B-tree (LSB-tree) that enables fast highdimensional NN search with excellent quality. The combination of several LSB-trees leads to a structure called the LSB-forest that ensures the same result quality as rigorous-LSH, but reduces its space and query cost dramatically. The LSB-forest also outperforms adhoc-LSH, even though the latter has no quality guarantee. Besides its appealing theoretical properties, the LSB-tree itself also serves as an effective index that consumes linear space, and supports efficient updates. Our extensive experiments confirm that the LSB-tree is faster than (i) the state of the art of exact NN search by two orders of magnitude, and (ii) the best (linear-space) method of approximate retrieval by an order of magnitude, and at the same time, returns neighbors with much better quality. © 2009 ACM.

  6. Finger vein identification using fuzzy-based k-nearest centroid neighbor classifier

    Science.gov (United States)

    Rosdi, Bakhtiar Affendi; Jaafar, Haryati; Ramli, Dzati Athiar

    2015-02-01

    In this paper, a new approach for personal identification using finger vein image is presented. Finger vein is an emerging type of biometrics that attracts attention of researchers in biometrics area. As compared to other biometric traits such as face, fingerprint and iris, finger vein is more secured and hard to counterfeit since the features are inside the human body. So far, most of the researchers focus on how to extract robust features from the captured vein images. Not much research was conducted on the classification of the extracted features. In this paper, a new classifier called fuzzy-based k-nearest centroid neighbor (FkNCN) is applied to classify the finger vein image. The proposed FkNCN employs a surrounding rule to obtain the k-nearest centroid neighbors based on the spatial distributions of the training images and their distance to the test image. Then, the fuzzy membership function is utilized to assign the test image to the class which is frequently represented by the k-nearest centroid neighbors. Experimental evaluation using our own database which was collected from 492 fingers shows that the proposed FkNCN has better performance than the k-nearest neighbor, k-nearest-centroid neighbor and fuzzy-based-k-nearest neighbor classifiers. This shows that the proposed classifier is able to identify the finger vein image effectively.

  7. FMEA and FTA Analyses of the Adhesive Joining Process using Electrically Conductive Adhesives

    Directory of Open Access Journals (Sweden)

    E. Povolotskaya

    2012-01-01

    Full Text Available This paper introduces a formulation of appropriate risk estimation methods that can be used for improving of processes in the electronics area. Two risk assessment methods have been chosen with regard to the specifics of adhesive joining based on electrically conductive adhesives. The paper provides a combination of a failure mode and effect analysis (FMEA and fault tree analysis (FTA for optimizing of the joining process. Typical features and failures of the process are identified. Critical operations are found and actions for avoiding failures in these actions are proposed. A fault treehas been applied to the process in order to get more precise information about the steps and operations in the process, and the relations between these operations. The fault tree identifies potential failures of the process. Then the effects of the failures have been estimated by the failure mode and effect analysis method. All major differences between failure mode and effect analysis and fault tree analysis are defined and there is a discussion about how to use the two techniquescomplement each other and achieve more efficient results.

  8. Two tree-formation methods for fast pattern search using nearest-neighbour and nearest-centroid matching

    NARCIS (Netherlands)

    Schomaker, Lambertus; Mangalagiu, D.; Vuurpijl, Louis; Weinfeld, M.; Schomaker, Lambert; Vuurpijl, Louis

    2000-01-01

    This paper describes tree­based classification of character images, comparing two methods of tree formation and two methods of matching: nearest neighbor and nearest centroid. The first method, Preprocess Using Relative Distances (PURD) is a tree­based reorganization of a flat list of patterns,

  9. Identifying Different Transportation Modes from Trajectory Data Using Tree-Based Ensemble Classifiers

    Directory of Open Access Journals (Sweden)

    Zhibin Xiao

    2017-02-01

    Full Text Available Recognition of transportation modes can be used in different applications including human behavior research, transport management and traffic control. Previous work on transportation mode recognition has often relied on using multiple sensors or matching Geographic Information System (GIS information, which is not possible in many cases. In this paper, an approach based on ensemble learning is proposed to infer hybrid transportation modes using only Global Position System (GPS data. First, in order to distinguish between different transportation modes, we used a statistical method to generate global features and extract several local features from sub-trajectories after trajectory segmentation, before these features were combined in the classification stage. Second, to obtain a better performance, we used tree-based ensemble models (Random Forest, Gradient Boosting Decision Tree, and XGBoost instead of traditional methods (K-Nearest Neighbor, Decision Tree, and Support Vector Machines to classify the different transportation modes. The experiment results on the later have shown the efficacy of our proposed approach. Among them, the XGBoost model produced the best performance with a classification accuracy of 90.77% obtained on the GEOLIFE dataset, and we used a tree-based ensemble method to ensure accurate feature selection to reduce the model complexity.

  10. Building Very Large Neighbour-Joining Trees

    DEFF Research Database (Denmark)

    Simonsen, Martin; Mailund, Thomas; Pedersen, Christian Nørgaard Storm

    2010-01-01

    , and the NJ method in general, becomes a problem when inferring phylogenies with 10000+ taxa. In this paper we present two extentions of RapidNJ which reduce memory requirements and enable RapidNJ to infer very large phylogenetic trees efficiently. We also present an improved search heuristic for Rapid...

  11. DNA barcoding and the identification of tree frogs (Amphibia: Anura: Rhacophoridae).

    Science.gov (United States)

    Dang, Ning-Xin; Sun, Feng-Hui; Lv, Yun-Yun; Zhao, Bo-Han; Wang, Ji-Chao; Murphy, Robert W; Wang, Wen-Zhi; Li, Jia-Tang

    2016-07-01

    The DNA barcoding gene COI (cytochrome c oxidase subunit I) effectively identifies many species. Herein, we barcoded 172 individuals from 37 species belonging to nine genera in Rhacophoridae to test if the gene serves equally well to identify species of tree frogs. Phenetic neighbor joining and phylogenetic Bayesian inference were used to construct phylogenetic trees, which resolved all nine genera as monophyletic taxa except for Rhacophorus, two new matrilines for Liuixalus, and Polypedates leucomystax species complex. Intraspecific genetic distances ranged from 0.000 to 0.119 and interspecific genetic distances ranged from 0.015 to 0.334. Within Rhacophorus and Kurixalus, the intra- and interspecific genetic distances did not reveal an obvious barcode gap. Notwithstanding, we found that COI sequences unambiguously identified rhacophorid species and helped to discover likely new cryptic species via the synthesis of genealogical relationships and divergence patterns. Our results supported that COI is an effective DNA barcoding marker for Rhacophoridae.

  12. SibRank: Signed bipartite network analysis for neighbor-based collaborative ranking

    Science.gov (United States)

    Shams, Bita; Haratizadeh, Saman

    2016-09-01

    Collaborative ranking is an emerging field of recommender systems that utilizes users' preference data rather than rating values. Unfortunately, neighbor-based collaborative ranking has gained little attention despite its more flexibility and justifiability. This paper proposes a novel framework, called SibRank that seeks to improve the state of the art neighbor-based collaborative ranking methods. SibRank represents users' preferences as a signed bipartite network, and finds similar users, through a novel personalized ranking algorithm in signed networks.

  13. New Joining Technology for Optimized Metal/Composite Assemblies

    Directory of Open Access Journals (Sweden)

    Holger Seidlitz

    2014-01-01

    Full Text Available The development of a new joining technology, which is used to manufacture high strength hybrid constructions with thermoplastic composites (FRP and metals, is introduced. Similar to natural regulation effects at trees, fibers around the FRP joint become aligned along the lines of force and will not be destroyed by the joining process. This is achieved by the local utilization of the specific plastic flow properties of the FRT and metal component. Compared with usual joining methods—such as flow drill screws, blind and self-piercing rivets—noticeably higher tensile properties can be realized through the novel process management. The load-bearing capability increasing effect could be proved on hybrid joints with hot-dip galvanized steel HX420LAD and orthotropic glass—as well as carbon—fiber reinforced plastics. The results, which were determined in tensile-shear and cross-shear tests according to DIN EN ISO 14273 and DIN EN ISO 14272, are compared with holding loads of established joining techniques with similar joining point diameter and material combinations.

  14. Trees in the city: valuing street trees in Portland, Oregon

    Science.gov (United States)

    G.H. Donovan; D.T. Butry

    2010-01-01

    We use a hedonic price model to simultaneously estimate the effects of street trees on the sales price and the time-on-market (TOM) of houses in Portland. Oregon. On average, street trees add $8,870 to sales price and reduce TOM by 1.7 days. In addition, we found that the benefits of street trees spill over to neighboring houses. Because the provision and maintenance...

  15. Integrated Automatic Workflow for Phylogenetic Tree Analysis Using Public Access and Local Web Services.

    Science.gov (United States)

    Damkliang, Kasikrit; Tandayya, Pichaya; Sangket, Unitsa; Pasomsub, Ekawat

    2016-11-28

    At the present, coding sequence (CDS) has been discovered and larger CDS is being revealed frequently. Approaches and related tools have also been developed and upgraded concurrently, especially for phylogenetic tree analysis. This paper proposes an integrated automatic Taverna workflow for the phylogenetic tree inferring analysis using public access web services at European Bioinformatics Institute (EMBL-EBI) and Swiss Institute of Bioinformatics (SIB), and our own deployed local web services. The workflow input is a set of CDS in the Fasta format. The workflow supports 1,000 to 20,000 numbers in bootstrapping replication. The workflow performs the tree inferring such as Parsimony (PARS), Distance Matrix - Neighbor Joining (DIST-NJ), and Maximum Likelihood (ML) algorithms of EMBOSS PHYLIPNEW package based on our proposed Multiple Sequence Alignment (MSA) similarity score. The local web services are implemented and deployed into two types using the Soaplab2 and Apache Axis2 deployment. There are SOAP and Java Web Service (JWS) providing WSDL endpoints to Taverna Workbench, a workflow manager. The workflow has been validated, the performance has been measured, and its results have been verified. Our workflow's execution time is less than ten minutes for inferring a tree with 10,000 replicates of the bootstrapping numbers. This paper proposes a new integrated automatic workflow which will be beneficial to the bioinformaticians with an intermediate level of knowledge and experiences. All local services have been deployed at our portal http://bioservices.sci.psu.ac.th.

  16. Benefit-based tree valuation

    Science.gov (United States)

    E.G. McPherson

    2007-01-01

    Benefit-based tree valuation provides alternative estimates of the fair and reasonable value of trees while illustrating the relative contribution of different benefit types. This study compared estimates of tree value obtained using cost- and benefit-based approaches. The cost-based approach used the Council of Landscape and Tree Appraisers trunk formula method, and...

  17. Nitrogen-fixing trees inhibit growth of regenerating Costa Rican rainforests.

    Science.gov (United States)

    Taylor, Benton N; Chazdon, Robin L; Bachelot, Benedicte; Menge, Duncan N L

    2017-08-15

    More than half of the world's tropical forests are currently recovering from human land use, and this regenerating biomass now represents the largest carbon (C)-capturing potential on Earth. How quickly these forests regenerate is now a central concern for both conservation and global climate-modeling efforts. Symbiotic nitrogen-fixing trees are thought to provide much of the nitrogen (N) required to fuel tropical secondary regrowth and therefore to drive the rate of forest regeneration, yet we have a poor understanding of how these N fixers influence the trees around them. Do they promote forest growth, as expected if the new N they fix facilitates neighboring trees? Or do they suppress growth, as expected if competitive inhibition of their neighbors is strong? Using 17 consecutive years of data from tropical rainforest plots in Costa Rica that range from 10 y since abandonment to old-growth forest, we assessed how N fixers influenced the growth of forest stands and the demographic rates of neighboring trees. Surprisingly, we found no evidence that N fixers facilitate biomass regeneration in these forests. At the hectare scale, plots with more N-fixing trees grew slower. At the individual scale, N fixers inhibited their neighbors even more strongly than did nonfixing trees. These results provide strong evidence that N-fixing trees do not always serve the facilitative role to neighboring trees during tropical forest regeneration that is expected given their N inputs into these systems.

  18. A Markov chain Monte Carlo Expectation Maximization Algorithm for Statistical Analysis of DNA Sequence Evolution with Neighbor-Dependent Substitution Rates

    DEFF Research Database (Denmark)

    Hobolth, Asger

    2008-01-01

    -dimensional integrals required in the EM algorithm are estimated using MCMC sampling. The MCMC sampler requires simulation of sample paths from a continuous time Markov process, conditional on the beginning and ending states and the paths of the neighboring sites. An exact path sampling algorithm is developed......The evolution of DNA sequences can be described by discrete state continuous time Markov processes on a phylogenetic tree. We consider neighbor-dependent evolutionary models where the instantaneous rate of substitution at a site depends on the states of the neighboring sites. Neighbor......-dependent substitution models are analytically intractable and must be analyzed using either approximate or simulation-based methods. We describe statistical inference of neighbor-dependent models using a Markov chain Monte Carlo expectation maximization (MCMC-EM) algorithm. In the MCMC-EM algorithm, the high...

  19. Mathematical analysis and modeling of epidemics of rubber tree root diseases: Probability of infection of an individual tree

    Energy Technology Data Exchange (ETDEWEB)

    Chadoeuf, J.; Joannes, H.; Nandris, D.; Pierrat, J.C.

    1988-12-01

    The spread of root diseases in rubber tree (Hevea brasiliensis) due to Rigidoporus lignosus and Phellinus noxius was investigated epidemiologically using data collected every 6 month during a 6-year survey in a plantation. The aim of the present study is to see what factors could predict whether a given tree would be infested at the following inspection. Using a qualitative regression method we expressed the probability of pathogenic attack on a tree in terms of three factors: the state of health of the surrounding trees, the method used to clear the forest prior to planting, and evolution with time. The effects of each factor were ranked, and the roles of the various classes of neighbors were established and quantified. Variability between successive inspections was small, and the method of forest clearing was important only while primary inocula in the soil were still infectious. The state of health of the immediate neighbors was most significant; more distant neighbors in the same row had some effect; interrow spread was extremely rare. This investigation dealt only with trees as individuals, and further study of the interrelationships of groups of trees is needed.

  20. Towards a formal genealogical classification of the Lezgian languages (North Caucasus: testing various phylogenetic methods on lexical data.

    Directory of Open Access Journals (Sweden)

    Alexei Kassian

    Full Text Available A lexicostatistical classification is proposed for 20 languages and dialects of the Lezgian group of the North Caucasian family, based on meticulously compiled 110-item wordlists, published as part of the Global Lexicostatistical Database project. The lexical data have been subsequently analyzed with the aid of the principal phylogenetic methods, both distance-based and character-based: Starling neighbor joining (StarlingNJ, Neighbor joining (NJ, Unweighted pair group method with arithmetic mean (UPGMA, Bayesian Markov chain Monte Carlo (MCMC, Unweighted maximum parsimony (UMP. Cognation indexes within the input matrix were marked by two different algorithms: traditional etymological approach and phonetic similarity, i.e., the automatic method of consonant classes (Levenshtein distances. Due to certain reasons (first of all, high lexicographic quality of the wordlists and a consensus about the Lezgian phylogeny among Caucasologists, the Lezgian database is a perfect testing area for appraisal of phylogenetic methods. For the etymology-based input matrix, all the phylogenetic methods, with the possible exception of UMP, have yielded trees that are sufficiently compatible with each other to generate a consensus phylogenetic tree of the Lezgian lects. The obtained consensus tree agrees with the traditional expert classification as well as some of the previously proposed formal classifications of this linguistic group. Contrary to theoretical expectations, the UMP method has suggested the least plausible tree of all. In the case of the phonetic similarity-based input matrix, the distance-based methods (StarlingNJ, NJ, UPGMA have produced the trees that are rather close to the consensus etymology-based tree and the traditional expert classification, whereas the character-based methods (Bayesian MCMC, UMP have yielded less likely topologies.

  1. Towards a formal genealogical classification of the Lezgian languages (North Caucasus): testing various phylogenetic methods on lexical data.

    Science.gov (United States)

    Kassian, Alexei

    2015-01-01

    A lexicostatistical classification is proposed for 20 languages and dialects of the Lezgian group of the North Caucasian family, based on meticulously compiled 110-item wordlists, published as part of the Global Lexicostatistical Database project. The lexical data have been subsequently analyzed with the aid of the principal phylogenetic methods, both distance-based and character-based: Starling neighbor joining (StarlingNJ), Neighbor joining (NJ), Unweighted pair group method with arithmetic mean (UPGMA), Bayesian Markov chain Monte Carlo (MCMC), Unweighted maximum parsimony (UMP). Cognation indexes within the input matrix were marked by two different algorithms: traditional etymological approach and phonetic similarity, i.e., the automatic method of consonant classes (Levenshtein distances). Due to certain reasons (first of all, high lexicographic quality of the wordlists and a consensus about the Lezgian phylogeny among Caucasologists), the Lezgian database is a perfect testing area for appraisal of phylogenetic methods. For the etymology-based input matrix, all the phylogenetic methods, with the possible exception of UMP, have yielded trees that are sufficiently compatible with each other to generate a consensus phylogenetic tree of the Lezgian lects. The obtained consensus tree agrees with the traditional expert classification as well as some of the previously proposed formal classifications of this linguistic group. Contrary to theoretical expectations, the UMP method has suggested the least plausible tree of all. In the case of the phonetic similarity-based input matrix, the distance-based methods (StarlingNJ, NJ, UPGMA) have produced the trees that are rather close to the consensus etymology-based tree and the traditional expert classification, whereas the character-based methods (Bayesian MCMC, UMP) have yielded less likely topologies.

  2. [Galaxy/quasar classification based on nearest neighbor method].

    Science.gov (United States)

    Li, Xiang-Ru; Lu, Yu; Zhou, Jian-Ming; Wang, Yong-Jun

    2011-09-01

    With the wide application of high-quality CCD in celestial spectrum imagery and the implementation of many large sky survey programs (e. g., Sloan Digital Sky Survey (SDSS), Two-degree-Field Galaxy Redshift Survey (2dF), Spectroscopic Survey Telescope (SST), Large Sky Area Multi-Object Fiber Spectroscopic Telescope (LAMOST) program and Large Synoptic Survey Telescope (LSST) program, etc.), celestial observational data are coming into the world like torrential rain. Therefore, to utilize them effectively and fully, research on automated processing methods for celestial data is imperative. In the present work, we investigated how to recognizing galaxies and quasars from spectra based on nearest neighbor method. Galaxies and quasars are extragalactic objects, they are far away from earth, and their spectra are usually contaminated by various noise. Therefore, it is a typical problem to recognize these two types of spectra in automatic spectra classification. Furthermore, the utilized method, nearest neighbor, is one of the most typical, classic, mature algorithms in pattern recognition and data mining, and often is used as a benchmark in developing novel algorithm. For applicability in practice, it is shown that the recognition ratio of nearest neighbor method (NN) is comparable to the best results reported in the literature based on more complicated methods, and the superiority of NN is that this method does not need to be trained, which is useful in incremental learning and parallel computation in mass spectral data processing. In conclusion, the results in this work are helpful for studying galaxies and quasars spectra classification.

  3. A Markov chain Monte Carlo Expectation Maximization Algorithm for Statistical Analysis of DNA Sequence Evolution with Neighbor-Dependent Substitution Rates

    DEFF Research Database (Denmark)

    Hobolth, Asger

    2008-01-01

    The evolution of DNA sequences can be described by discrete state continuous time Markov processes on a phylogenetic tree. We consider neighbor-dependent evolutionary models where the instantaneous rate of substitution at a site depends on the states of the neighboring sites. Neighbor...

  4. A Novel Preferential Diffusion Recommendation Algorithm Based on User’s Nearest Neighbors

    Directory of Open Access Journals (Sweden)

    Fuguo Zhang

    2017-01-01

    Full Text Available Recommender system is a very efficient way to deal with the problem of information overload for online users. In recent years, network based recommendation algorithms have demonstrated much better performance than the standard collaborative filtering methods. However, most of network based algorithms do not give a high enough weight to the influence of the target user’s nearest neighbors in the resource diffusion process, while a user or an object with high degree will obtain larger influence in the standard mass diffusion algorithm. In this paper, we propose a novel preferential diffusion recommendation algorithm considering the significance of the target user’s nearest neighbors and evaluate it in the three real-world data sets: MovieLens 100k, MovieLens 1M, and Epinions. Experiments results demonstrate that the novel preferential diffusion recommendation algorithm based on user’s nearest neighbors can significantly improve the recommendation accuracy and diversity.

  5. On Tree-Based Phylogenetic Networks.

    Science.gov (United States)

    Zhang, Louxin

    2016-07-01

    A large class of phylogenetic networks can be obtained from trees by the addition of horizontal edges between the tree edges. These networks are called tree-based networks. We present a simple necessary and sufficient condition for tree-based networks and prove that a universal tree-based network exists for any number of taxa that contains as its base every phylogenetic tree on the same set of taxa. This answers two problems posted by Francis and Steel recently. A byproduct is a computer program for generating random binary phylogenetic networks under the uniform distribution model.

  6. Alternative electro-chemically based processing routes for joining of plasma facing components

    Energy Technology Data Exchange (ETDEWEB)

    Krauss, Wolfgang, E-mail: wolfgang.krauss@kit.edu [Karlsruhe Institute of Technology (KIT), Institute for Materials Research III, Hermann-von-Helmholtz-Platz 1 76344 Eggenstein-Leopoldshafen (Germany); Lorenz, Julia; Holstein, Nils; Konys, Juergen [Karlsruhe Institute of Technology (KIT), Institute for Materials Research III, Hermann-von-Helmholtz-Platz 1 76344 Eggenstein-Leopoldshafen (Germany)

    2011-10-15

    Tungsten is considered in fusion technology as functional and structural material in the area of blanket and divertor for future application in DEMO. The KIT design of a He-cooled divertor includes joints between W and W-alloys as well as of W with Eurofer-steel. The main challenges range from expansion mismatch problem for tungsten/steel joints over metallurgical reactions with brittle phase formation to crack stopping ability and excellent surface wetting. These requirements were only met partly and insufficiently in the past e.g. by direct Cu-casting of tungsten onto steel. Both, the joining needs and the observed failure scenarios of conventionally joined components initiated the development of improved joining technologies based on electro-chemical processing routes. As electrolytes aqueous and aprotic, water free, system are integrated into this development line. In the first step principle requirements are presented to guarantee a reproducible and adherent deposition of scales based on Ni and Cu acting as inter layers and filler, respectively, to generate a real metallurgical bonding as demonstrate by 1100 deg. C joining tests. The development field aprotic systems based on ionic liquids is discussed with respect to enable development of refractory metal based fillers with focus high temperature W-W brazing.

  7. A Novel AMR-WB Speech Steganography Based on Diameter-Neighbor Codebook Partition

    Directory of Open Access Journals (Sweden)

    Junhui He

    2018-01-01

    Full Text Available Steganography is a means of covert communication without revealing the occurrence and the real purpose of communication. The adaptive multirate wideband (AMR-WB is a widely adapted format in mobile handsets and is also the recommended speech codec for VoLTE. In this paper, a novel AMR-WB speech steganography is proposed based on diameter-neighbor codebook partition algorithm. Different embedding capacity may be achieved by adjusting the iterative parameters during codebook division. The experimental results prove that the presented AMR-WB steganography may provide higher and flexible embedding capacity without inducing perceptible distortion compared with the state-of-the-art methods. With 48 iterations of cluster merging, twice the embedding capacity of complementary-neighbor-vertices-based embedding method may be obtained with a decrease of only around 2% in speech quality and much the same undetectability. Moreover, both the quality of stego speech and the security regarding statistical steganalysis are better than the recent speech steganography based on neighbor-index-division codebook partition.

  8. Nonbinary Tree-Based Phylogenetic Networks.

    Science.gov (United States)

    Jetten, Laura; van Iersel, Leo

    2018-01-01

    Rooted phylogenetic networks are used to describe evolutionary histories that contain non-treelike evolutionary events such as hybridization and horizontal gene transfer. In some cases, such histories can be described by a phylogenetic base-tree with additional linking arcs, which can, for example, represent gene transfer events. Such phylogenetic networks are called tree-based. Here, we consider two possible generalizations of this concept to nonbinary networks, which we call tree-based and strictly-tree-based nonbinary phylogenetic networks. We give simple graph-theoretic characterizations of tree-based and strictly-tree-based nonbinary phylogenetic networks. Moreover, we show for each of these two classes that it can be decided in polynomial time whether a given network is contained in the class. Our approach also provides a new view on tree-based binary phylogenetic networks. Finally, we discuss two examples of nonbinary phylogenetic networks in biology and show how our results can be applied to them.

  9. Sorghum bicolor, L.

    African Journals Online (AJOL)

    Tuoyo Aghomotsegin

    2016-06-08

    -dimensional space. Population structure analysis ... Despite similar weather characteristics in the two regions, preliminary results ..... results generated through STRUCTURE were used to color-code the neighbor-joining tree.

  10. نام واحد:

    African Journals Online (AJOL)

    mahdi

    JN573359. Multiple sequence alignments were performed using. MEGA version 5 (Tamura et al., 2011) after obtaining multiple alignments of data available from public databases by Clustal W. (Hall, 1999). Phylogenetic tree was inferred by using neighbor joining tree making algorithm (Saitou and Nei, 1987). Zinc removal.

  11. Forest structure of Mediterranean yew (Taxus baccata L. populations and neighbor effects on juvenile yew performance in the NE Iberian Peninsula

    Directory of Open Access Journals (Sweden)

    Pere Casals

    2015-12-01

    Full Text Available Aim of study: In the Mediterranean region, yew (Taxus baccata L. usually grows with other tree species in mixed forests. Yew recruitment and juvenile growth may depend on the structure of the forest and the net balance between competition for soil water and nutrients with neighbors and facilitation that these neighbors exert by protecting the plants from direct sun exposure. This study aims, at a regional scale, to analyze the structure of forests containing yew, and, on an individual level, to analyze the effect of the surrounding vegetation structure on the performance of yew juveniles.Area of study: The structural typologies of yew populations were defined based on field inventories conducted in 55 plots distributed in 14 localities in the North-Eastern (NE Iberian Peninsula, covering a wide range of yew distribution in the area. In a second step, an analysis of neighboring species' effects on juveniles was conducted based on the data from 103 plots centered in yew juveniles in five localities.Main Results: A cluster analysis classified the inventoried stands into four forest structural types: two multi-stratified forests with scattered yew and two yew groves. Multiple regression modeling showed that the δ13C measured in last year's leaves positively relates to the basal area of conifer neighbors, but negatively with the cover of the yew crown by other trees.Research highlights: At a stand-level, the density of recruits and juveniles (625 ± 104 recruits ha-1, 259 ± 55 juveniles ha-1 in mixed forests was found to be higher than that on yew dominant stands (181 ± 88 recruits ha-1 and 57 ± 88 juveniles ha-1. At an individual-level, the water stress (estimated from leaf δ13C of yew juveniles seems alleviated by the crown cover by neighbors while it increases with the basal area of conifers. Yew conservation should focus on selective felling for the reduction of basal area of neighbors surrounding the target tree, but avoid affecting the

  12. RBT—A Tool for Building Refined Buneman Trees

    DEFF Research Database (Denmark)

    Besenbacher, Søren; Mailund; Westh-Nielsen, Lasse

    2005-01-01

    We have developed a tool implementing an efficient algorithm for refined Buneman tree reconstruction. The algorithm—which has the same complexity as the neighbour-joining method and the (plain) Buneman tree construction—enables refined Buneman tree reconstruction on large taxa sets....

  13. Effectiveness of phylogenomic data and coalescent species-tree methods for resolving difficult nodes in the phylogeny of advanced snakes (Serpentes: Caenophidia).

    Science.gov (United States)

    Pyron, R Alexander; Hendry, Catriona R; Chou, Vincent M; Lemmon, Emily M; Lemmon, Alan R; Burbrink, Frank T

    2014-12-01

    Next-generation genomic sequencing promises to quickly and cheaply resolve remaining contentious nodes in the Tree of Life, and facilitates species-tree estimation while taking into account stochastic genealogical discordance among loci. Recent methods for estimating species trees bypass full likelihood-based estimates of the multi-species coalescent, and approximate the true species-tree using simpler summary metrics. These methods converge on the true species-tree with sufficient genomic sampling, even in the anomaly zone. However, no studies have yet evaluated their efficacy on a large-scale phylogenomic dataset, and compared them to previous concatenation strategies. Here, we generate such a dataset for Caenophidian snakes, a group with >2500 species that contains several rapid radiations that were poorly resolved with fewer loci. We generate sequence data for 333 single-copy nuclear loci with ∼100% coverage (∼0% missing data) for 31 major lineages. We estimate phylogenies using neighbor joining, maximum parsimony, maximum likelihood, and three summary species-tree approaches (NJst, STAR, and MP-EST). All methods yield similar resolution and support for most nodes. However, not all methods support monophyly of Caenophidia, with Acrochordidae placed as the sister taxon to Pythonidae in some analyses. Thus, phylogenomic species-tree estimation may occasionally disagree with well-supported relationships from concatenated analyses of small numbers of nuclear or mitochondrial genes, a consideration for future studies. In contrast for at least two diverse, rapid radiations (Lamprophiidae and Colubridae), phylogenomic data and species-tree inference do little to improve resolution and support. Thus, certain nodes may lack strong signal, and larger datasets and more sophisticated analyses may still fail to resolve them. Copyright © 2014 Elsevier Inc. All rights reserved.

  14. Nearest Neighbor Networks: clustering expression data based on gene neighborhoods

    Directory of Open Access Journals (Sweden)

    Olszewski Kellen L

    2007-07-01

    Full Text Available Abstract Background The availability of microarrays measuring thousands of genes simultaneously across hundreds of biological conditions represents an opportunity to understand both individual biological pathways and the integrated workings of the cell. However, translating this amount of data into biological insight remains a daunting task. An important initial step in the analysis of microarray data is clustering of genes with similar behavior. A number of classical techniques are commonly used to perform this task, particularly hierarchical and K-means clustering, and many novel approaches have been suggested recently. While these approaches are useful, they are not without drawbacks; these methods can find clusters in purely random data, and even clusters enriched for biological functions can be skewed towards a small number of processes (e.g. ribosomes. Results We developed Nearest Neighbor Networks (NNN, a graph-based algorithm to generate clusters of genes with similar expression profiles. This method produces clusters based on overlapping cliques within an interaction network generated from mutual nearest neighborhoods. This focus on nearest neighbors rather than on absolute distance measures allows us to capture clusters with high connectivity even when they are spatially separated, and requiring mutual nearest neighbors allows genes with no sufficiently similar partners to remain unclustered. We compared the clusters generated by NNN with those generated by eight other clustering methods. NNN was particularly successful at generating functionally coherent clusters with high precision, and these clusters generally represented a much broader selection of biological processes than those recovered by other methods. Conclusion The Nearest Neighbor Networks algorithm is a valuable clustering method that effectively groups genes that are likely to be functionally related. It is particularly attractive due to its simplicity, its success in the

  15. A Benchmark of Lidar-Based Single Tree Detection Methods Using Heterogeneous Forest Data from the Alpine Space

    Directory of Open Access Journals (Sweden)

    Lothar Eysn

    2015-05-01

    Full Text Available In this study, eight airborne laser scanning (ALS-based single tree detection methods are benchmarked and investigated. The methods were applied to a unique dataset originating from different regions of the Alpine Space covering different study areas, forest types, and structures. This is the first benchmark ever performed for different forests within the Alps. The evaluation of the detection results was carried out in a reproducible way by automatically matching them to precise in situ forest inventory data using a restricted nearest neighbor detection approach. Quantitative statistical parameters such as percentages of correctly matched trees and omission and commission errors are presented. The proposed automated matching procedure presented herein shows an overall accuracy of 97%. Method based analysis, investigations per forest type, and an overall benchmark performance are presented. The best matching rate was obtained for single-layered coniferous forests. Dominated trees were challenging for all methods. The overall performance shows a matching rate of 47%, which is comparable to results of other benchmarks performed in the past. The study provides new insight regarding the potential and limits of tree detection with ALS and underlines some key aspects regarding the choice of method when performing single tree detection for the various forest types encountered in alpine regions.

  16. A two-step nearest neighbors algorithm using satellite imagery for predicting forest structure within species composition classes

    Science.gov (United States)

    Ronald E. McRoberts

    2009-01-01

    Nearest neighbors techniques have been shown to be useful for predicting multiple forest attributes from forest inventory and Landsat satellite image data. However, in regions lacking good digital land cover information, nearest neighbors selected to predict continuous variables such as tree volume must be selected without regard to relevant categorical variables such...

  17. On the Expressiveness of Joining

    Directory of Open Access Journals (Sweden)

    Thomas Given-Wilson

    2015-08-01

    Full Text Available The expressiveness of communication primitives has been explored in a common framework based on the pi-calculus by considering four features: synchronism (asynchronous vs synchronous, arity (monadic vs polyadic data, communication medium (shared dataspaces vs channel-based, and pattern-matching (binding to a name vs testing name equality vs intensionality. Here another dimension coordination is considered that accounts for the number of processes required for an interaction to occur. Coordination generalises binary languages such as pi-calculus to joining languages that combine inputs such as the Join Calculus and general rendezvous calculus. By means of possibility/impossibility of encodings, this paper shows coordination is unrelated to the other features. That is, joining languages are more expressive than binary languages, and no combination of the other features can encode a joining language into a binary language. Further, joining is not able to encode any of the other features unless they could be encoded otherwise.

  18. Neighboring Structure Visualization on a Grid-based Layout.

    Science.gov (United States)

    Marcou, G; Horvath, D; Varnek, A

    2017-10-01

    Here, we describe an algorithm to visualize chemical structures on a grid-based layout in such a way that similar structures are neighboring. It is based on structure reordering with the help of the Hilbert Schmidt Independence Criterion, representing an empirical estimate of the Hilbert-Schmidt norm of the cross-covariance operator. The method can be applied to any layout of bi- or three-dimensional shape. The approach is demonstrated on a set of dopamine D5 ligands visualized on squared, disk and spherical layouts. © 2017 Wiley-VCH Verlag GmbH & Co. KGaA, Weinheim.

  19. Reduction in predator defense in the presence of neighbors in a colonial fish.

    Directory of Open Access Journals (Sweden)

    Franziska C Schädelin

    Full Text Available Predation pressure has long been considered a leading explanation of colonies, where close neighbors may reduce predation via dilution, alarming or group predator attacks. Attacking predators may be costly in terms of energy and survival, leading to the question of how neighbors contribute to predator deterrence in relationship to each other. Two hypotheses explaining the relative efforts made by neighbors are byproduct-mutualism, which occurs when breeders inadvertently attack predators by defending their nests, and reciprocity, which occurs when breeders deliberately exchange predator defense efforts with neighbors. Most studies investigating group nest defense have been performed with birds. However, colonial fish may constitute a more practical model system for an experimental approach because of the greater ability of researchers to manipulate their environment. We investigated in the colonial fish, Neolamprologus caudopunctatus, whether prospecting pairs preferred to breed near conspecifics or solitarily, and how breeders invested in anti-predator defense in relation to neighbors. In a simple choice test, prospecting pairs selected breeding sites close to neighbors versus a solitary site. Predators were then sequentially presented to the newly established test pairs, the previously established stimulus pairs or in between the two pairs. Test pairs attacked the predator eight times more frequently when they were presented on their non-neighbor side compared to between the two breeding sites, where stimulus pairs maintained high attack rates. Thus, by joining an established pair, test pairs were able to reduce their anti-predator efforts near neighbors, at no apparent cost to the stimulus pairs. These findings are unlikely to be explained by reciprocity or byproduct-mutualism. Our results instead suggest a commensal relationship in which new pairs exploit the high anti-predator efforts of established pairs, which invest similarly with or

  20. On Determining if Tree-based Networks Contain Fixed Trees.

    Science.gov (United States)

    Anaya, Maria; Anipchenko-Ulaj, Olga; Ashfaq, Aisha; Chiu, Joyce; Kaiser, Mahedi; Ohsawa, Max Shoji; Owen, Megan; Pavlechko, Ella; St John, Katherine; Suleria, Shivam; Thompson, Keith; Yap, Corrine

    2016-05-01

    We address an open question of Francis and Steel about phylogenetic networks and trees. They give a polynomial time algorithm to decide if a phylogenetic network, N, is tree-based and pose the problem: given a fixed tree T and network N, is N based on T? We show that it is [Formula: see text]-hard to decide, by reduction from 3-Dimensional Matching (3DM) and further that the problem is fixed-parameter tractable.

  1. The influence of sampling unit size and spatial arrangement patterns on neighborhood-based spatial structure analyses of forest stands

    Energy Technology Data Exchange (ETDEWEB)

    Wang, H.; Zhang, G.; Hui, G.; Li, Y.; Hu, Y.; Zhao, Z.

    2016-07-01

    Aim of study: Neighborhood-based stand spatial structure parameters can quantify and characterize forest spatial structure effectively. How these neighborhood-based structure parameters are influenced by the selection of different numbers of nearest-neighbor trees is unclear, and there is some disagreement in the literature regarding the appropriate number of nearest-neighbor trees to sample around reference trees. Understanding how to efficiently characterize forest structure is critical for forest management. Area of study: Multi-species uneven-aged forests of Northern China. Material and methods: We simulated stands with different spatial structural characteristics and systematically compared their structure parameters when two to eight neighboring trees were selected. Main results: Results showed that values of uniform angle index calculated in the same stand were different with different sizes of structure unit. When tree species and sizes were completely randomly interspersed, different numbers of neighbors had little influence on mingling and dominance indices. Changes of mingling or dominance indices caused by different numbers of neighbors occurred when the tree species or size classes were not randomly interspersed and their changing characteristics can be detected according to the spatial arrangement patterns of tree species and sizes. Research highlights: The number of neighboring trees selected for analyzing stand spatial structure parameters should be fixed. We proposed that the four-tree structure unit is the best compromise between sampling accuracy and costs for practical forest management. (Author)

  2. Joining-Splitting Interaction of Noncritical String

    Science.gov (United States)

    Hadasz, Leszek; Jaskólski, Zbigniew

    The joining-splitting interaction of noncritical bosonic string is analyzed in the light-cone formulation. The Mandelstam method of constructing tree string amplitudes is extended to the bosonic massive string models of the discrete series. The general properties of the Liouville longitudinal excitations which are necessary and sufficient for the Lorentz covariance of the light-cone amplitudes are derived. The results suggest that the covariant and the light-cone approach are equivalent also in the noncritical dimensions. Some aspects of unitarity of interacting noncritical massive string theory are discussed.

  3. Classifying dysmorphic syndromes by using artificial neural network based hierarchical decision tree.

    Science.gov (United States)

    Özdemir, Merve Erkınay; Telatar, Ziya; Eroğul, Osman; Tunca, Yusuf

    2018-05-01

    Dysmorphic syndromes have different facial malformations. These malformations are significant to an early diagnosis of dysmorphic syndromes and contain distinctive information for face recognition. In this study we define the certain features of each syndrome by considering facial malformations and classify Fragile X, Hurler, Prader Willi, Down, Wolf Hirschhorn syndromes and healthy groups automatically. The reference points are marked on the face images and ratios between the points' distances are taken into consideration as features. We suggest a neural network based hierarchical decision tree structure in order to classify the syndrome types. We also implement k-nearest neighbor (k-NN) and artificial neural network (ANN) classifiers to compare classification accuracy with our hierarchical decision tree. The classification accuracy is 50, 73 and 86.7% with k-NN, ANN and hierarchical decision tree methods, respectively. Then, the same images are shown to a clinical expert who achieve a recognition rate of 46.7%. We develop an efficient system to recognize different syndrome types automatically in a simple, non-invasive imaging data, which is independent from the patient's age, sex and race at high accuracy. The promising results indicate that our method can be used for pre-diagnosis of the dysmorphic syndromes by clinical experts.

  4. Bioinformatics analysis and construction of phylogenetic tree of aquaporins from Echinococcus granulosus.

    Science.gov (United States)

    Wang, Fen; Ye, Bin

    2016-09-01

    Cyst echinococcosis caused by the matacestodal larvae of Echinococcus granulosus (Eg), is a chronic, worldwide, and severe zoonotic parasitosis. The treatment of cyst echinococcosis is still difficult since surgery cannot fit the needs of all patients, and drugs can lead to serious adverse events as well as resistance. The screen of target proteins interacted with new anti-hydatidosis drugs is urgently needed to meet the prevailing challenges. Here, we analyzed the sequences and structure properties, and constructed a phylogenetic tree by bioinformatics methods. The MIP family signature and Protein kinase C phosphorylation sites were predicted in all nine EgAQPs. α-helix and random coil were the main secondary structures of EgAQPs. The numbers of transmembrane regions were three to six, which indicated that EgAQPs contained multiple hydrophobic regions. A neighbor-joining tree indicated that EgAQPs were divided into two branches, seven EgAQPs formed a clade with AQP1 from human, a "strict" aquaporins, other two EgAQPs formed a clade with AQP9 from human, an aquaglyceroporins. Unfortunately, homology modeling of EgAQPs was aborted. These results provide a foundation for understanding and researches of the biological function of E. granulosus.

  5. Nonbinary tree-based phylogenetic networks

    OpenAIRE

    Jetten, Laura; van Iersel, Leo

    2016-01-01

    Rooted phylogenetic networks are used to describe evolutionary histories that contain non-treelike evolutionary events such as hybridization and horizontal gene transfer. In some cases, such histories can be described by a phylogenetic base-tree with additional linking arcs, which can for example represent gene transfer events. Such phylogenetic networks are called tree-based. Here, we consider two possible generalizations of this concept to nonbinary networks, which we call tree-based and st...

  6. Superplasticity and joining of zirconia-based ceramics

    International Nuclear Information System (INIS)

    Dominguez-Rodriguez, A.; Gutierrez-Mora, F.; Jimenez-Melendo, M.; Chaim, R.; Routbort, J. L.

    1999-01-01

    Steady-state creep and joining of alumina/zirconia composites containing alumina volume fractions of 20, 60, and 85% have been investigated between 1,250 and 1,350 C. Superplasticity of these compounds is controlled by grain-boundary sliding and the creep rate is a function of alumina volume fraction, not grain size. Using the principles of superplasticity, pieces of the composite have been joined by applying the stress required to achieve 5 to 10% strain to form a strong interface at temperatures as low as 1,200 C

  7. Superplasticity and joining of zirconia-based ceramics

    International Nuclear Information System (INIS)

    Gutierrez-Mora, F.; Dominguez-Rodriguez, A.; Jimenez-Melendo, M.; Chaim, R.; Ravi, G.B.; Routbort, J.L.

    2000-01-01

    Steady-state creep and joining of alumina/zirconia composites containing alumina volume fractions of 20, 60 and 85% have been investigated between 1,250 and 1,350 C. Superplasticity of these compounds is controlled by grain-boundary sliding and the creep rate is a function of alumina volume fraction, not grain size. Using the principles of superplasticity, pieces of the composite have been joined by applying the stress required to achieve 5 to 10% strain to form a strong interface at temperatures as low as 1,200 C

  8. Local-scale drivers of tree survival in a temperate forest.

    Science.gov (United States)

    Wang, Xugao; Comita, Liza S; Hao, Zhanqing; Davies, Stuart J; Ye, Ji; Lin, Fei; Yuan, Zuoqiang

    2012-01-01

    Tree survival plays a central role in forest ecosystems. Although many factors such as tree size, abiotic and biotic neighborhoods have been proposed as being important in explaining patterns of tree survival, their contributions are still subject to debate. We used generalized linear mixed models to examine the relative importance of tree size, local abiotic conditions and the density and identity of neighbors on tree survival in an old-growth temperate forest in northeastern China at three levels (community, guild and species). Tree size and both abiotic and biotic neighborhood variables influenced tree survival under current forest conditions, but their relative importance varied dramatically within and among the community, guild and species levels. Of the variables tested, tree size was typically the most important predictor of tree survival, followed by biotic and then abiotic variables. The effect of tree size on survival varied from strongly positive for small trees (1-20 cm dbh) and medium trees (20-40 cm dbh), to slightly negative for large trees (>40 cm dbh). Among the biotic factors, we found strong evidence for negative density and frequency dependence in this temperate forest, as indicated by negative effects of both total basal area of neighbors and the frequency of conspecific neighbors. Among the abiotic factors tested, soil nutrients tended to be more important in affecting tree survival than topographic variables. Abiotic factors generally influenced survival for species with relatively high abundance, for individuals in smaller size classes and for shade-tolerant species. Our study demonstrates that the relative importance of variables driving patterns of tree survival differs greatly among size classes, species guilds and abundance classes in temperate forest, which can further understanding of forest dynamics and offer important insights into forest management.

  9. Genetic variation and forensic characteristic analysis of 25 STRs of a novel fluorescence co-amplification system in Chinese Southern Shaanxi Han population

    Science.gov (United States)

    Liu, Yao-Shun; Chen, Jian-Gang; Mei, Ting; Guo, Yu-Xin; Meng, Hao-Tian; Li, Jian-Fei; Wei, Yuan-Yuan; Jin, Xiao-Ye; Zhu, Bo-Feng; Zhang, Li-Ping

    2017-01-01

    We analyzed the genetic polymorphisms of 15 autosomal and 10 Y-chromosomal STR loci in 214 individuals of Han population from Southern Shaanxi of China and studied the genetic relationships between Southern Shaanxi Han and other populations. We observed a total of 150 alleles at 15 autosomal STR loci with the corresponding allelic frequencies ranging from 0.0023 to 0.5210, and the combined power of discrimination and exclusion for the 15 autosomal STR loci were 0.99999999999999998866 and 0.999998491, respectively. For the 10 Y-STR loci, totally 100 different haplotypes were obtained, of which 94 were unique. The discriminatory capacity and haplotype diversity values of the 10 Y-STR loci were 0.9259 and 0.998269, respectively. The results demonstrated high genetic diversities of the 25 STR loci in the population for forensic applications. We constructed neighbor-joining tree and conducted principal component analysis based on 15 autosomal STR loci and conducted multidimensional scaling analysis and constructed neighbor-joining tree based on 10 Y-STR loci. The results of population genetic analyses based on both autosomal and Y-chromosome STRs indicated that the studied Southern Shaanxi Han population had relatively closer genetic relationship with Eastern Han population, and distant relationships with Croatian, Serbian and Moroccan populations. PMID:28903432

  10. Fermilab Friends for Science Education | Tree of Knowledge

    Science.gov (United States)

    Fermilab Friends for Science Education FFSE Home About Us Join Us Support Us Contact Us Tree of Testimonials Our Donors Board of Directors Board Tools Calendar Join Us Donate Now Get FermiGear! Education precollege science education programs. Prominently displayed at the Lederman Science Center is the lovely

  11. Dissimilarity-based classification of anatomical tree structures

    DEFF Research Database (Denmark)

    Sørensen, Lauge; Lo, Pechin Chien Pau; Dirksen, Asger

    2011-01-01

    A novel method for classification of abnormality in anatomical tree structures is presented. A tree is classified based on direct comparisons with other trees in a dissimilarity-based classification scheme. The pair-wise dissimilarity measure between two trees is based on a linear assignment betw...

  12. Dissimilarity-based classification of anatomical tree structures

    DEFF Research Database (Denmark)

    Sørensen, Lauge Emil Borch Laurs; Lo, Pechin Chien Pau; Dirksen, Asger

    2011-01-01

    A novel method for classification of abnormality in anatomical tree structures is presented. A tree is classified based on direct comparisons with other trees in a dissimilarity-based classification scheme. The pair-wise dissimilarity measure between two trees is based on a linear assignment...

  13. Attribute Weighting Based K-Nearest Neighbor Using Gain Ratio

    Science.gov (United States)

    Nababan, A. A.; Sitompul, O. S.; Tulus

    2018-04-01

    K- Nearest Neighbor (KNN) is a good classifier, but from several studies, the result performance accuracy of KNN still lower than other methods. One of the causes of the low accuracy produced, because each attribute has the same effect on the classification process, while some less relevant characteristics lead to miss-classification of the class assignment for new data. In this research, we proposed Attribute Weighting Based K-Nearest Neighbor Using Gain Ratio as a parameter to see the correlation between each attribute in the data and the Gain Ratio also will be used as the basis for weighting each attribute of the dataset. The accuracy of results is compared to the accuracy acquired from the original KNN method using 10-fold Cross-Validation with several datasets from the UCI Machine Learning repository and KEEL-Dataset Repository, such as abalone, glass identification, haberman, hayes-roth and water quality status. Based on the result of the test, the proposed method was able to increase the classification accuracy of KNN, where the highest difference of accuracy obtained hayes-roth dataset is worth 12.73%, and the lowest difference of accuracy obtained in the abalone dataset of 0.07%. The average result of the accuracy of all dataset increases the accuracy by 5.33%.

  14. Identifying influential neighbors in animal flocking.

    Directory of Open Access Journals (Sweden)

    Li Jiang

    2017-11-01

    Full Text Available Schools of fish and flocks of birds can move together in synchrony and decide on new directions of movement in a seamless way. This is possible because group members constantly share directional information with their neighbors. Although detecting the directionality of other group members is known to be important to maintain cohesion, it is not clear how many neighbors each individual can simultaneously track and pay attention to, and what the spatial distribution of these influential neighbors is. Here, we address these questions on shoals of Hemigrammus rhodostomus, a species of fish exhibiting strong schooling behavior. We adopt a data-driven analysis technique based on the study of short-term directional correlations to identify which neighbors have the strongest influence over the participation of an individual in a collective U-turn event. We find that fish mainly react to one or two neighbors at a time. Moreover, we find no correlation between the distance rank of a neighbor and its likelihood to be influential. We interpret our results in terms of fish allocating sequential and selective attention to their neighbors.

  15. Identifying influential neighbors in animal flocking.

    Science.gov (United States)

    Jiang, Li; Giuggioli, Luca; Perna, Andrea; Escobedo, Ramón; Lecheval, Valentin; Sire, Clément; Han, Zhangang; Theraulaz, Guy

    2017-11-01

    Schools of fish and flocks of birds can move together in synchrony and decide on new directions of movement in a seamless way. This is possible because group members constantly share directional information with their neighbors. Although detecting the directionality of other group members is known to be important to maintain cohesion, it is not clear how many neighbors each individual can simultaneously track and pay attention to, and what the spatial distribution of these influential neighbors is. Here, we address these questions on shoals of Hemigrammus rhodostomus, a species of fish exhibiting strong schooling behavior. We adopt a data-driven analysis technique based on the study of short-term directional correlations to identify which neighbors have the strongest influence over the participation of an individual in a collective U-turn event. We find that fish mainly react to one or two neighbors at a time. Moreover, we find no correlation between the distance rank of a neighbor and its likelihood to be influential. We interpret our results in terms of fish allocating sequential and selective attention to their neighbors.

  16. ESTIMATING PHOTOMETRIC REDSHIFTS OF QUASARS VIA THE k-NEAREST NEIGHBOR APPROACH BASED ON LARGE SURVEY DATABASES

    Energy Technology Data Exchange (ETDEWEB)

    Zhang Yanxia; Ma He; Peng Nanbo; Zhao Yongheng [Key Laboratory of Optical Astronomy, National Astronomical Observatories, Chinese Academy of Sciences, 100012 Beijing (China); Wu Xuebing, E-mail: zyx@bao.ac.cn [Department of Astronomy, Peking University, 100871 Beijing (China)

    2013-08-01

    We apply one of the lazy learning methods, the k-nearest neighbor (kNN) algorithm, to estimate the photometric redshifts of quasars based on various data sets from the Sloan Digital Sky Survey (SDSS), the UKIRT Infrared Deep Sky Survey (UKIDSS), and the Wide-field Infrared Survey Explorer (WISE; the SDSS sample, the SDSS-UKIDSS sample, the SDSS-WISE sample, and the SDSS-UKIDSS-WISE sample). The influence of the k value and different input patterns on the performance of kNN is discussed. kNN performs best when k is different with a special input pattern for a special data set. The best result belongs to the SDSS-UKIDSS-WISE sample. The experimental results generally show that the more information from more bands, the better performance of photometric redshift estimation with kNN. The results also demonstrate that kNN using multiband data can effectively solve the catastrophic failure of photometric redshift estimation, which is met by many machine learning methods. Compared with the performance of various other methods of estimating the photometric redshifts of quasars, kNN based on KD-Tree shows superiority, exhibiting the best accuracy.

  17. ESTIMATING PHOTOMETRIC REDSHIFTS OF QUASARS VIA THE k-NEAREST NEIGHBOR APPROACH BASED ON LARGE SURVEY DATABASES

    International Nuclear Information System (INIS)

    Zhang Yanxia; Ma He; Peng Nanbo; Zhao Yongheng; Wu Xuebing

    2013-01-01

    We apply one of the lazy learning methods, the k-nearest neighbor (kNN) algorithm, to estimate the photometric redshifts of quasars based on various data sets from the Sloan Digital Sky Survey (SDSS), the UKIRT Infrared Deep Sky Survey (UKIDSS), and the Wide-field Infrared Survey Explorer (WISE; the SDSS sample, the SDSS-UKIDSS sample, the SDSS-WISE sample, and the SDSS-UKIDSS-WISE sample). The influence of the k value and different input patterns on the performance of kNN is discussed. kNN performs best when k is different with a special input pattern for a special data set. The best result belongs to the SDSS-UKIDSS-WISE sample. The experimental results generally show that the more information from more bands, the better performance of photometric redshift estimation with kNN. The results also demonstrate that kNN using multiband data can effectively solve the catastrophic failure of photometric redshift estimation, which is met by many machine learning methods. Compared with the performance of various other methods of estimating the photometric redshifts of quasars, kNN based on KD-Tree shows superiority, exhibiting the best accuracy.

  18. Efficient Joins with Compressed Bitmap Indexes

    Energy Technology Data Exchange (ETDEWEB)

    Computational Research Division; Madduri, Kamesh; Wu, Kesheng

    2009-08-19

    We present a new class of adaptive algorithms that use compressed bitmap indexes to speed up evaluation of the range join query in relational databases. We determine the best strategy to process a join query based on a fast sub-linear time computation of the join selectivity (the ratio of the number of tuples in the result to the total number of possible tuples). In addition, we use compressed bitmaps to represent the join output compactly: the space requirement for storing the tuples representing the join of two relations is asymptotically bounded by min(h; n . cb), where h is the number of tuple pairs in the result relation, n is the number of tuples in the smaller of the two relations, and cb is the cardinality of the larger column being joined. We present a theoretical analysis of our algorithms, as well as experimental results on large-scale synthetic and real data sets. Our implementations are efficient, and consistently outperform well-known approaches for a range of join selectivity factors. For instance, our count-only algorithm is up to three orders of magnitude faster than the sort-merge approach, and our best bitmap index-based algorithm is 1.2x-80x faster than the sort-merge algorithm, for various query instances. We achieve these speedups by exploiting several inherent performance advantages of compressed bitmap indexes for join processing: an implicit partitioning of the attributes, space-efficiency, and tolerance of high-cardinality relations.

  19. Authenticated join processing in outsourced databases

    KAUST Repository

    Yang, Yin

    2009-01-01

    Database outsourcing requires that a query server constructs a proof of result correctness, which can be verified by the client using the data owner\\'s signature. Previous authentication techniques deal with range queries on a single relation using an authenticated data structure (ADS). On the other hand, authenticated join processing is inherently more complex than ranges since only the base relations (but not their combination) are signed by the owner. In this paper, we present three novel join algorithms depending on the ADS availability: (i) Authenticated Indexed Sort Merge Join (AISM), which utilizes a single ADS on the join attribute, (ii) Authenticated Index Merge Join (AIM) that requires an ADS (on the join attribute) for both relations, and (iii) Authenticated Sort Merge Join (ASM), which does not rely on any ADS. We experimentally demonstrate that the proposed methods outperform two benchmark algorithms, often by several orders of magnitude, on all performance metrics, and effectively shift the workload to the outsourcing service. Finally, we extend our techniques to complex queries that combine multi-way joins with selections and projections. ©2009 ACM.

  20. Authenticated join processing in outsourced databases

    KAUST Repository

    Yang, Yin; Papadias, Dimitris; Papadopoulos, Stavros; Kalnis, Panos

    2009-01-01

    Database outsourcing requires that a query server constructs a proof of result correctness, which can be verified by the client using the data owner's signature. Previous authentication techniques deal with range queries on a single relation using an authenticated data structure (ADS). On the other hand, authenticated join processing is inherently more complex than ranges since only the base relations (but not their combination) are signed by the owner. In this paper, we present three novel join algorithms depending on the ADS availability: (i) Authenticated Indexed Sort Merge Join (AISM), which utilizes a single ADS on the join attribute, (ii) Authenticated Index Merge Join (AIM) that requires an ADS (on the join attribute) for both relations, and (iii) Authenticated Sort Merge Join (ASM), which does not rely on any ADS. We experimentally demonstrate that the proposed methods outperform two benchmark algorithms, often by several orders of magnitude, on all performance metrics, and effectively shift the workload to the outsourcing service. Finally, we extend our techniques to complex queries that combine multi-way joins with selections and projections. ©2009 ACM.

  1. Comprehensive Phylogenetic Analysis of Bovine Non-aureus Staphylococci Species Based on Whole-Genome Sequencing

    Science.gov (United States)

    Naushad, Sohail; Barkema, Herman W.; Luby, Christopher; Condas, Larissa A. Z.; Nobrega, Diego B.; Carson, Domonique A.; De Buck, Jeroen

    2016-01-01

    Non-aureus staphylococci (NAS), a heterogeneous group of a large number of species and subspecies, are the most frequently isolated pathogens from intramammary infections in dairy cattle. Phylogenetic relationships among bovine NAS species are controversial and have mostly been determined based on single-gene trees. Herein, we analyzed phylogeny of bovine NAS species using whole-genome sequencing (WGS) of 441 distinct isolates. In addition, evolutionary relationships among bovine NAS were estimated from multilocus data of 16S rRNA, hsp60, rpoB, sodA, and tuf genes and sequences from these and numerous other single genes/proteins. All phylogenies were created with FastTree, Maximum-Likelihood, Maximum-Parsimony, and Neighbor-Joining methods. Regardless of methodology, WGS-trees clearly separated bovine NAS species into five monophyletic coherent clades. Furthermore, there were consistent interspecies relationships within clades in all WGS phylogenetic reconstructions. Except for the Maximum-Parsimony tree, multilocus data analysis similarly produced five clades. There were large variations in determining clades and interspecies relationships in single gene/protein trees, under different methods of tree constructions, highlighting limitations of using single genes for determining bovine NAS phylogeny. However, based on WGS data, we established a robust phylogeny of bovine NAS species, unaffected by method or model of evolutionary reconstructions. Therefore, it is now possible to determine associations between phylogeny and many biological traits, such as virulence, antimicrobial resistance, environmental niche, geographical distribution, and host specificity. PMID:28066335

  2. Evidence for cultural differences between neighboring chimpanzee communities.

    Science.gov (United States)

    Luncz, Lydia V; Mundry, Roger; Boesch, Christophe

    2012-05-22

    The majority of evidence for cultural behavior in animals has come from comparisons between populations separated by large geographical distances that often inhabit different environments. The difficulty of excluding ecological and genetic variation as potential explanations for observed behaviors has led some researchers to challenge the idea of animal culture. Chimpanzees (Pan troglodytes verus) in the Taï National Park, Côte d'Ivoire, crack Coula edulis nuts using stone and wooden hammers and tree root anvils. In this study, we compare for the first time hammer selection for nut cracking across three neighboring chimpanzee communities that live in the same forest habitat, which reduces the likelihood of ecological variation. Furthermore, the study communities experience frequent dispersal of females at maturity, which eliminates significant genetic variation. We compared key ecological factors, such as hammer availability and nut hardness, between the three neighboring communities and found striking differences in group-specific hammer selection among communities despite similar ecological conditions. Differences were found in the selection of hammer material and hammer size in response to changes in nut resistance over time. Our findings highlight the subtleties of cultural differences in wild chimpanzees and illustrate how cultural knowledge is able to shape behavior, creating differences among neighboring social groups. Copyright © 2012 Elsevier Ltd. All rights reserved.

  3. Multi-level tree analysis of pulmonary artery/vein trees in non-contrast CT images

    Science.gov (United States)

    Gao, Zhiyun; Grout, Randall W.; Hoffman, Eric A.; Saha, Punam K.

    2012-02-01

    Diseases like pulmonary embolism and pulmonary hypertension are associated with vascular dystrophy. Identifying such pulmonary artery/vein (A/V) tree dystrophy in terms of quantitative measures via CT imaging significantly facilitates early detection of disease or a treatment monitoring process. A tree structure, consisting of nodes and connected arcs, linked to the volumetric representation allows multi-level geometric and volumetric analysis of A/V trees. Here, a new theory and method is presented to generate multi-level A/V tree representation of volumetric data and to compute quantitative measures of A/V tree geometry and topology at various tree hierarchies. The new method is primarily designed on arc skeleton computation followed by a tree construction based topologic and geometric analysis of the skeleton. The method starts with a volumetric A/V representation as input and generates its topologic and multi-level volumetric tree representations long with different multi-level morphometric measures. A new recursive merging and pruning algorithms are introduced to detect bad junctions and noisy branches often associated with digital geometric and topologic analysis. Also, a new notion of shortest axial path is introduced to improve the skeletal arc joining two junctions. The accuracy of the multi-level tree analysis algorithm has been evaluated using computer generated phantoms and pulmonary CT images of a pig vessel cast phantom while the reproducibility of method is evaluated using multi-user A/V separation of in vivo contrast-enhanced CT images of a pig lung at different respiratory volumes.

  4. Transforming phylogenetic networks: Moving beyond tree space

    OpenAIRE

    Huber, Katharina T.; Moulton, Vincent; Wu, Taoyang

    2016-01-01

    Phylogenetic networks are a generalization of phylogenetic trees that are used to represent reticulate evolution. Unrooted phylogenetic networks form a special class of such networks, which naturally generalize unrooted phylogenetic trees. In this paper we define two operations on unrooted phylogenetic networks, one of which is a generalization of the well-known nearest-neighbor interchange (NNI) operation on phylogenetic trees. We show that any unrooted phylogenetic network can be transforme...

  5. A General Self-Organized Tree-Based Energy-Balance Routing Protocol for Wireless Sensor Network

    Science.gov (United States)

    Han, Zhao; Wu, Jie; Zhang, Jie; Liu, Liefeng; Tian, Kaiyun

    2014-04-01

    Wireless sensor network (WSN) is a system composed of a large number of low-cost micro-sensors. This network is used to collect and send various kinds of messages to a base station (BS). WSN consists of low-cost nodes with limited battery power, and the battery replacement is not easy for WSN with thousands of physically embedded nodes, which means energy efficient routing protocol should be employed to offer a long-life work time. To achieve the aim, we need not only to minimize total energy consumption but also to balance WSN load. Researchers have proposed many protocols such as LEACH, HEED, PEGASIS, TBC and PEDAP. In this paper, we propose a General Self-Organized Tree-Based Energy-Balance routing protocol (GSTEB) which builds a routing tree using a process where, for each round, BS assigns a root node and broadcasts this selection to all sensor nodes. Subsequently, each node selects its parent by considering only itself and its neighbors' information, thus making GSTEB a dynamic protocol. Simulation results show that GSTEB has a better performance than other protocols in balancing energy consumption, thus prolonging the lifetime of WSN.

  6. LifePrint: a novel k-tuple distance method for construction of phylogenetic trees

    Directory of Open Access Journals (Sweden)

    Fabián Reyes-Prieto

    2011-01-01

    Full Text Available Fabián Reyes-Prieto1, Adda J García-Chéquer1, Hueman Jaimes-Díaz1, Janet Casique-Almazán1, Juana M Espinosa-Lara1, Rosaura Palma-Orozco2, Alfonso Méndez-Tenorio1, Rogelio Maldonado-Rodríguez1, Kenneth L Beattie31Laboratory of Biotechnology and Genomic Bioinformatics, Department of Biochemistry, National School of Biological Sciences, 2Superior School of Computer Sciences, National Polytechnic Institute, Mexico City, Mexico; 3Amerigenics Inc, Crossville, Tennessee, USAPurpose: Here we describe LifePrint, a sequence alignment-independent k-tuple distance method to estimate relatedness between complete genomes.Methods: We designed a representative sample of all possible DNA tuples of length 9 (9-tuples. The final sample comprises 1878 tuples (called the LifePrint set of 9-tuples; LPS9 that are distinct from each other by at least two internal and noncontiguous nucleotide differences. For validation of our k-tuple distance method, we analyzed several real and simulated viroid genomes. Using different distance metrics, we scrutinized diverse viroid genomes to estimate the k-tuple distances between these genomic sequences. Then we used the estimated genomic k-tuple distances to construct phylogenetic trees using the neighbor-joining algorithm. A comparison of the accuracy of LPS9 and the previously reported 5-tuple method was made using symmetric differences between the trees estimated from each method and a simulated “true” phylogenetic tree.Results: The identified optimal search scheme for LPS9 allows only up to two nucleotide differences between each 9-tuple and the scrutinized genome. Similarity search results of simulated viroid genomes indicate that, in most cases, LPS9 is able to detect single-base substitutions between genomes efficiently. Analysis of simulated genomic variants with a high proportion of base substitutions indicates that LPS9 is able to discern relationships between genomic variants with up to 40% of nucleotide

  7. GENETIC DIFFERENTIATION AMONG POPULATIONS OF Chromobotia macracanthus BLEEKER FROM SUMATRA AND KALIMANTAN BASED ON SEQUENCING GENE OF MTDNA CYTOCHROME B AND NUCLEUS DNA RAG2

    Directory of Open Access Journals (Sweden)

    Sudarto Sudarto

    2008-12-01

    Full Text Available Research on genetic differentiation among populations of Chromobotia macracanthus Bleeker from Sumatra, based on sequencing gene of mtDNA Cytochrome b and nucleus DNA RAG2 has been done. The objectives of the study were to obtain the representation of genetic differentiation among population of clown loach fishes or botia (Chromobotia macracanthus from Sumatra and Kalimantan and to estimate the time divergence of both population group of botia. Samples of botia population were taken from 3 rivers in Sumatra namely Batanghari, Musi, and Tulang Bawang and one river from Kalimantan namely Kapuas. The genetic analysis was based on the sequencing of mtDNA Cytochrome b and nucleus DNA RAG2. The statistical analysis was done by using APE package on R language. The parameters observed were: nucleotide diversity, genetic distance, and neighbor-joining tree. The result showed that the highest nucleotide diversity was fish population of Musi, while the other two populations, Tulang Bawang (Sumatra and Kapuas (Kalimantan, were considered as the lowest genetic diversity especially based on nucleus DNA RAG2 sequencing. Based on mtDNA Cytochrome-b sequencing, the most distinct population among those populations based on genetic distance were fish populations of Musi and Kapuas. According to the result of neighbor-joining tree analysis, the populations of botia were classified into two groups namely group of Sumatra and group of Kalimantan. The estimation of time divergence among group of population of Sumatra and Kalimantan based on mtDNA Cytochrome b was about 9.25—9.46 million years (Miocene era. The high genetic differences between groups of Sumatra and Kalimantan suggested that the effort of restocking botia from Sumatra into Kalimantan has to be done carefully, because it may disturb the gene originality of both botia populations.

  8. Ring-constrained Join

    DEFF Research Database (Denmark)

    Yiu, Man Lung; Karras, Panagiotis; Mamoulis, Nikos

    2008-01-01

    . This new operation has important applications in decision support, e.g., placing recycling stations at fair locations between restaurants and residential complexes. Clearly, RCJ is defined based on a geometric constraint but not on distances between points. Thus, our operation is fundamentally different......We introduce a novel spatial join operator, the ring-constrained join (RCJ). Given two sets P and Q of spatial points, the result of RCJ consists of pairs (p, q) (where p ε P, q ε Q) satisfying an intuitive geometric constraint: the smallest circle enclosing p and q contains no other points in P, Q...

  9. Expressive Power of Tree and String Based Wrappers

    OpenAIRE

    Ikeda, Daisuke; Yamada, Yasuhiro; Hirokawa, Sachio

    2003-01-01

    There exist two types of wrappers: the string based wrapper such as the LR wrapper, and the tree based wrapper. A tree based wrapper designates extraction regions by nodes on the trees of semistructured documents. The tree based wrapper seems to be more powerful than the string based one. There exist, however, manyHTML documents on the Web such that a standard tree based wrapper fails to extract contents because they are structured by presentational tags, punctuation symbols, and white spaces...

  10. Rapid and Robust Cross-Correlation-Based Seismic Phase Identification Using an Approximate Nearest Neighbor Method

    Science.gov (United States)

    Tibi, R.; Young, C. J.; Gonzales, A.; Ballard, S.; Encarnacao, A. V.

    2016-12-01

    The matched filtering technique involving the cross-correlation of a waveform of interest with archived signals from a template library has proven to be a powerful tool for detecting events in regions with repeating seismicity. However, waveform correlation is computationally expensive, and therefore impractical for large template sets unless dedicated distributed computing hardware and software are used. In this study, we introduce an Approximate Nearest Neighbor (ANN) approach that enables the use of very large template libraries for waveform correlation without requiring a complex distributed computing system. Our method begins with a projection into a reduced dimensionality space based on correlation with a randomized subset of the full template archive. Searching for a specified number of nearest neighbors is accomplished by using randomized K-dimensional trees. We used the approach to search for matches to each of 2700 analyst-reviewed signal detections reported for May 2010 for the IMS station MKAR. The template library in this case consists of a dataset of more than 200,000 analyst-reviewed signal detections for the same station from 2002-2014 (excluding May 2010). Of these signal detections, 60% are teleseismic first P, and 15% regional phases (Pn, Pg, Sn, and Lg). The analyses performed on a standard desktop computer shows that the proposed approach performs the search of the large template libraries about 20 times faster than the standard full linear search, while achieving recall rates greater than 80%, with the recall rate increasing for higher correlation values. To decide whether to confirm a match, we use a hybrid method involving a cluster approach for queries with two or more matches, and correlation score for single matches. Of the signal detections that passed our confirmation process, 52% were teleseismic first P, and 30% were regional phases.

  11. a Gross Error Elimination Method for Point Cloud Data Based on Kd-Tree

    Science.gov (United States)

    Kang, Q.; Huang, G.; Yang, S.

    2018-04-01

    Point cloud data has been one type of widely used data sources in the field of remote sensing. Key steps of point cloud data's pro-processing focus on gross error elimination and quality control. Owing to the volume feature of point could data, existed gross error elimination methods need spend massive memory both in space and time. This paper employed a new method which based on Kd-tree algorithm to construct, k-nearest neighbor algorithm to search, settled appropriate threshold to determine with result turns out a judgement that whether target point is or not an outlier. Experimental results show that, our proposed algorithm will help to delete gross error in point cloud data and facilitate to decrease memory consumption, improve efficiency.

  12. A GROSS ERROR ELIMINATION METHOD FOR POINT CLOUD DATA BASED ON KD-TREE

    Directory of Open Access Journals (Sweden)

    Q. Kang

    2018-04-01

    Full Text Available Point cloud data has been one type of widely used data sources in the field of remote sensing. Key steps of point cloud data’s pro-processing focus on gross error elimination and quality control. Owing to the volume feature of point could data, existed gross error elimination methods need spend massive memory both in space and time. This paper employed a new method which based on Kd-tree algorithm to construct, k-nearest neighbor algorithm to search, settled appropriate threshold to determine with result turns out a judgement that whether target point is or not an outlier. Experimental results show that, our proposed algorithm will help to delete gross error in point cloud data and facilitate to decrease memory consumption, improve efficiency.

  13. FB-Tree: A B+-Tree for Flash-Based SSDs

    DEFF Research Database (Denmark)

    Jørgensen, Martin V.; Rasmussen, René B.; Saltenis, Simonas

    2011-01-01

    Due to their many advantages, flash-based SSDs (Solid-State Drives) have become a mainstream alternative to magnetic disks for database servers. Nevertheless, database systems, designed and optimized for magnetic disks, still do not fully exploit all the benefits of the new technology. We propose....... As a consequence, the FB-tree outperforms a regular B+-tree in all scenarios tested. For instance, the throughput of a random workload of 75% updates increases by a factor of three using only two times the space of the B+-tree....

  14. Improved Fuzzy K-Nearest Neighbor Using Modified Particle Swarm Optimization

    Science.gov (United States)

    Jamaluddin; Siringoringo, Rimbun

    2017-12-01

    Fuzzy k-Nearest Neighbor (FkNN) is one of the most powerful classification methods. The presence of fuzzy concepts in this method successfully improves its performance on almost all classification issues. The main drawbackof FKNN is that it is difficult to determine the parameters. These parameters are the number of neighbors (k) and fuzzy strength (m). Both parameters are very sensitive. This makes it difficult to determine the values of ‘m’ and ‘k’, thus making FKNN difficult to control because no theories or guides can deduce how proper ‘m’ and ‘k’ should be. This study uses Modified Particle Swarm Optimization (MPSO) to determine the best value of ‘k’ and ‘m’. MPSO is focused on the Constriction Factor Method. Constriction Factor Method is an improvement of PSO in order to avoid local circumstances optima. The model proposed in this study was tested on the German Credit Dataset. The test of the data/The data test has been standardized by UCI Machine Learning Repository which is widely applied to classification problems. The application of MPSO to the determination of FKNN parameters is expected to increase the value of classification performance. Based on the experiments that have been done indicating that the model offered in this research results in a better classification performance compared to the Fk-NN model only. The model offered in this study has an accuracy rate of 81%, while. With using Fk-NN model, it has the accuracy of 70%. At the end is done comparison of research model superiority with 2 other classification models;such as Naive Bayes and Decision Tree. This research model has a better performance level, where Naive Bayes has accuracy 75%, and the decision tree model has 70%

  15. Precision Joining Center

    Science.gov (United States)

    Powell, J. W.; Westphal, D. A.

    1991-08-01

    A workshop to obtain input from industry on the establishment of the Precision Joining Center (PJC) was held on July 10-12, 1991. The PJC is a center for training Joining Technologists in advanced joining techniques and concepts in order to promote the competitiveness of U.S. industry. The center will be established as part of the DOE Defense Programs Technology Commercialization Initiative, and operated by EG&G Rocky Flats in cooperation with the American Welding Society and the Colorado School of Mines Center for Welding and Joining Research. The overall objectives of the workshop were to validate the need for a Joining Technologists to fill the gap between the welding operator and the welding engineer, and to assure that the PJC will train individuals to satisfy that need. The consensus of the workshop participants was that the Joining Technologist is a necessary position in industry, and is currently used, with some variation, by many companies. It was agreed that the PJC core curriculum, as presented, would produce a Joining Technologist of value to industries that use precision joining techniques. The advantage of the PJC would be to train the Joining Technologist much more quickly and more completely. The proposed emphasis of the PJC curriculum on equipment intensive and hands-on training was judged to be essential.

  16. On Competitiveness of Nearest-Neighbor-Based Music Classification: A Methodological Critique

    DEFF Research Database (Denmark)

    Pálmason, Haukur; Jónsson, Björn Thór; Amsaleg, Laurent

    2017-01-01

    The traditional role of nearest-neighbor classification in music classification research is that of a straw man opponent for the learning approach of the hour. Recent work in high-dimensional indexing has shown that approximate nearest-neighbor algorithms are extremely scalable, yielding results...... of reasonable quality from billions of high-dimensional features. With such efficient large-scale classifiers, the traditional music classification methodology of aggregating and compressing the audio features is incorrect; instead the approximate nearest-neighbor classifier should be given an extensive data...... collection to work with. We present a case study, using a well-known MIR classification benchmark with well-known music features, which shows that a simple nearest-neighbor classifier performs very competitively when given ample data. In this position paper, we therefore argue that nearest...

  17. Base Stock Policy in a Join-Type Production Line with Advanced Demand Information

    Science.gov (United States)

    Hiraiwa, Mikihiko; Tsubouchi, Satoshi; Nakade, Koichi

    Production control such as the base stock policy, the kanban policy and the constant work-in-process policy in a serial production line has been studied by many researchers. Production lines, however, usually have fork-type, join-type or network-type figures. In addition, in most previous studies on production control, a finished product is required at the same time as arrival of demand at the system. Demand information is, however, informed before due date in practice. In this paper a join-type (assembly) production line under base stock control with advanced demand information in discrete time is analyzed. The recursive equations for the work-in-process are derived. The heuristic algorithm for finding appropriate base stock levels of all machines at short time is proposed and the effect of advanced demand information is examined by simulation with the proposed algorithm. It is shown that the inventory cost can decreases with little backlogs by using the appropriate amount of demand information and setting appropriate base stock levels.

  18. Geodesic atlas-based labeling of anatomical trees

    DEFF Research Database (Denmark)

    Feragen, Aasa; Petersen, Jens; Owen, Megan

    2015-01-01

    We present a fast and robust atlas-based algorithm for labeling airway trees, using geodesic distances in a geometric tree-space. Possible branch label configurations for an unlabeled airway tree are evaluated using distances to a training set of labeled airway trees. In tree-space, airway tree t...... equally complete airway trees, and comparable in performance to that of experts in pulmonary medicine, emphasizing the suitability of the labeling algorithm for clinical use....

  19. Parallel trajectory similarity joins in spatial networks

    KAUST Repository

    Shang, Shuo

    2018-04-04

    The matching of similar pairs of objects, called similarity join, is fundamental functionality in data management. We consider two cases of trajectory similarity joins (TS-Joins), including a threshold-based join (Tb-TS-Join) and a top-k TS-Join (k-TS-Join), where the objects are trajectories of vehicles moving in road networks. Given two sets of trajectories and a threshold θ, the Tb-TS-Join returns all pairs of trajectories from the two sets with similarity above θ. In contrast, the k-TS-Join does not take a threshold as a parameter, and it returns the top-k most similar trajectory pairs from the two sets. The TS-Joins target diverse applications such as trajectory near-duplicate detection, data cleaning, ridesharing recommendation, and traffic congestion prediction. With these applications in mind, we provide purposeful definitions of similarity. To enable efficient processing of the TS-Joins on large sets of trajectories, we develop search space pruning techniques and enable use of the parallel processing capabilities of modern processors. Specifically, we present a two-phase divide-and-conquer search framework that lays the foundation for the algorithms for the Tb-TS-Join and the k-TS-Join that rely on different pruning techniques to achieve efficiency. For each trajectory, the algorithms first find similar trajectories. Then they merge the results to obtain the final result. The algorithms for the two joins exploit different upper and lower bounds on the spatiotemporal trajectory similarity and different heuristic scheduling strategies for search space pruning. Their per-trajectory searches are independent of each other and can be performed in parallel, and the mergings have constant cost. An empirical study with real data offers insight in the performance of the algorithms and demonstrates that they are capable of outperforming well-designed baseline algorithms by an order of magnitude.

  20. Parallel trajectory similarity joins in spatial networks

    KAUST Repository

    Shang, Shuo; Chen, Lisi; Wei, Zhewei; Jensen, Christian S.; Zheng, Kai; Kalnis, Panos

    2018-01-01

    The matching of similar pairs of objects, called similarity join, is fundamental functionality in data management. We consider two cases of trajectory similarity joins (TS-Joins), including a threshold-based join (Tb-TS-Join) and a top-k TS-Join (k-TS-Join), where the objects are trajectories of vehicles moving in road networks. Given two sets of trajectories and a threshold θ, the Tb-TS-Join returns all pairs of trajectories from the two sets with similarity above θ. In contrast, the k-TS-Join does not take a threshold as a parameter, and it returns the top-k most similar trajectory pairs from the two sets. The TS-Joins target diverse applications such as trajectory near-duplicate detection, data cleaning, ridesharing recommendation, and traffic congestion prediction. With these applications in mind, we provide purposeful definitions of similarity. To enable efficient processing of the TS-Joins on large sets of trajectories, we develop search space pruning techniques and enable use of the parallel processing capabilities of modern processors. Specifically, we present a two-phase divide-and-conquer search framework that lays the foundation for the algorithms for the Tb-TS-Join and the k-TS-Join that rely on different pruning techniques to achieve efficiency. For each trajectory, the algorithms first find similar trajectories. Then they merge the results to obtain the final result. The algorithms for the two joins exploit different upper and lower bounds on the spatiotemporal trajectory similarity and different heuristic scheduling strategies for search space pruning. Their per-trajectory searches are independent of each other and can be performed in parallel, and the mergings have constant cost. An empirical study with real data offers insight in the performance of the algorithms and demonstrates that they are capable of outperforming well-designed baseline algorithms by an order of magnitude.

  1. Estimating Stand Height and Tree Density in Pinus taeda plantations using in-situ data, airborne LiDAR and k-Nearest Neighbor Imputation.

    Science.gov (United States)

    Silva, Carlos Alberto; Klauberg, Carine; Hudak, Andrew T; Vierling, Lee A; Liesenberg, Veraldo; Bernett, Luiz G; Scheraiber, Clewerson F; Schoeninger, Emerson R

    2018-01-01

    Accurate forest inventory is of great economic importance to optimize the entire supply chain management in pulp and paper companies. The aim of this study was to estimate stand dominate and mean heights (HD and HM) and tree density (TD) of Pinus taeda plantations located in South Brazil using in-situ measurements, airborne Light Detection and Ranging (LiDAR) data and the non- k-nearest neighbor (k-NN) imputation. Forest inventory attributes and LiDAR derived metrics were calculated at 53 regular sample plots and we used imputation models to retrieve the forest attributes at plot and landscape-levels. The best LiDAR-derived metrics to predict HD, HM and TD were H99TH, HSD, SKE and HMIN. The Imputation model using the selected metrics was more effective for retrieving height than tree density. The model coefficients of determination (adj.R2) and a root mean squared difference (RMSD) for HD, HM and TD were 0.90, 0.94, 0.38m and 6.99, 5.70, 12.92%, respectively. Our results show that LiDAR and k-NN imputation can be used to predict stand heights with high accuracy in Pinus taeda. However, furthers studies need to be realized to improve the accuracy prediction of TD and to evaluate and compare the cost of acquisition and processing of LiDAR data against the conventional inventory procedures.

  2. Neighbors United for Health

    Science.gov (United States)

    Westhoff, Wayne W.; Corvin, Jaime; Virella, Irmarie

    2009-01-01

    Modeled upon the ecclesiastic community group concept of Latin America to unite and strengthen the bond between the Church and neighborhoods, a community-based organization created Vecinos Unidos por la Salud (Neighbors United for Health) to bring health messages into urban Latino neighborhoods. The model is based on five tenants, and incorporates…

  3. History-based joins : semantics, soundness and implementation

    NARCIS (Netherlands)

    Hee, van K.M.; Oanea, O.I.; Serebrenik, A.; Sidorova, N.; Voorhoeve, M.; Dustdar, S.; Fiadeiro, J.L.; Sheth, A.

    2006-01-01

    In this paper we study the use of case history for control structures in workflow processes. In particular we introduce a historydependent join. History dependent control offers much more modeling power than classical control structures and it solves several semantical problems of industrial

  4. Equivalent charge source model based iterative maximum neighbor weight for sparse EEG source localization.

    Science.gov (United States)

    Xu, Peng; Tian, Yin; Lei, Xu; Hu, Xiao; Yao, Dezhong

    2008-12-01

    How to localize the neural electric activities within brain effectively and precisely from the scalp electroencephalogram (EEG) recordings is a critical issue for current study in clinical neurology and cognitive neuroscience. In this paper, based on the charge source model and the iterative re-weighted strategy, proposed is a new maximum neighbor weight based iterative sparse source imaging method, termed as CMOSS (Charge source model based Maximum neighbOr weight Sparse Solution). Different from the weight used in focal underdetermined system solver (FOCUSS) where the weight for each point in the discrete solution space is independently updated in iterations, the new designed weight for each point in each iteration is determined by the source solution of the last iteration at both the point and its neighbors. Using such a new weight, the next iteration may have a bigger chance to rectify the local source location bias existed in the previous iteration solution. The simulation studies with comparison to FOCUSS and LORETA for various source configurations were conducted on a realistic 3-shell head model, and the results confirmed the validation of CMOSS for sparse EEG source localization. Finally, CMOSS was applied to localize sources elicited in a visual stimuli experiment, and the result was consistent with those source areas involved in visual processing reported in previous studies.

  5. Phylogenetic relationships of Malayan gaur with other species of the genus Bos based on cytochrome b gene DNA sequences.

    Science.gov (United States)

    Rosli, M K A; Zakaria, S S; Syed-Shabthar, S M F; Zainal, Z Z; Shukor, M N; Mahani, M C; Abas-Mazni, O; Md-Zain, B M

    2011-03-22

    The Malayan gaur (Bos gaurus hubbacki) is one of the three subspecies of gaurs that can be found in Malaysia. We examined the phylogenetic relationships of this subspecies with other species of the genus Bos (B. javanicus, B. indicus, B. taurus, and B. grunniens). The sequence of a key gene, cytochrome b, was compared among 20 Bos species and the bongo antelope, used as an outgroup. Phylogenetic reconstruction was employed using neighbor joining and maximum parsimony in PAUP and Bayesian inference in MrBayes 3.1. All tree topologies indicated that the Malayan gaur is in its own monophyletic clade, distinct from other species of the genus Bos. We also found significant branching differences in the tree topologies between wild and domestic cattle.

  6. Foraging Behaviour in Magellanic Woodpeckers Is Consistent with a Multi-Scale Assessment of Tree Quality.

    Directory of Open Access Journals (Sweden)

    Pablo M Vergara

    Full Text Available Theoretical models predict that animals should make foraging decisions after assessing the quality of available habitat, but most models fail to consider the spatio-temporal scales at which animals perceive habitat availability. We tested three foraging strategies that explain how Magellanic woodpeckers (Campephilus magellanicus assess the relative quality of trees: 1 Woodpeckers with local knowledge select trees based on the available trees in the immediate vicinity. 2 Woodpeckers lacking local knowledge select trees based on their availability at previously visited locations. 3 Woodpeckers using information from long-term memory select trees based on knowledge about trees available within the entire landscape. We observed foraging woodpeckers and used a Brownian Bridge Movement Model to identify trees available to woodpeckers along foraging routes. Woodpeckers selected trees with a later decay stage than available trees. Selection models indicated that preferences of Magellanic woodpeckers were based on clusters of trees near the most recently visited trees, thus suggesting that woodpeckers use visual cues from neighboring trees. In a second analysis, Cox's proportional hazards models showed that woodpeckers used information consolidated across broader spatial scales to adjust tree residence times. Specifically, woodpeckers spent more time at trees with larger diameters and in a more advanced stage of decay than trees available along their routes. These results suggest that Magellanic woodpeckers make foraging decisions based on the relative quality of trees that they perceive and memorize information at different spatio-temporal scales.

  7. Decision tree-based learning to predict patient controlled analgesia consumption and readjustment

    Directory of Open Access Journals (Sweden)

    Hu Yuh-Jyh

    2012-11-01

    Full Text Available Abstract Background Appropriate postoperative pain management contributes to earlier mobilization, shorter hospitalization, and reduced cost. The under treatment of pain may impede short-term recovery and have a detrimental long-term effect on health. This study focuses on Patient Controlled Analgesia (PCA, which is a delivery system for pain medication. This study proposes and demonstrates how to use machine learning and data mining techniques to predict analgesic requirements and PCA readjustment. Methods The sample in this study included 1099 patients. Every patient was described by 280 attributes, including the class attribute. In addition to commonly studied demographic and physiological factors, this study emphasizes attributes related to PCA. We used decision tree-based learning algorithms to predict analgesic consumption and PCA control readjustment based on the first few hours of PCA medications. We also developed a nearest neighbor-based data cleaning method to alleviate the class-imbalance problem in PCA setting readjustment prediction. Results The prediction accuracies of total analgesic consumption (continuous dose and PCA dose and PCA analgesic requirement (PCA dose only by an ensemble of decision trees were 80.9% and 73.1%, respectively. Decision tree-based learning outperformed Artificial Neural Network, Support Vector Machine, Random Forest, Rotation Forest, and Naïve Bayesian classifiers in analgesic consumption prediction. The proposed data cleaning method improved the performance of every learning method in this study of PCA setting readjustment prediction. Comparative analysis identified the informative attributes from the data mining models and compared them with the correlates of analgesic requirement reported in previous works. Conclusion This study presents a real-world application of data mining to anesthesiology. Unlike previous research, this study considers a wider variety of predictive factors, including PCA

  8. Frog sound identification using extended k-nearest neighbor classifier

    Science.gov (United States)

    Mukahar, Nordiana; Affendi Rosdi, Bakhtiar; Athiar Ramli, Dzati; Jaafar, Haryati

    2017-09-01

    Frog sound identification based on the vocalization becomes important for biological research and environmental monitoring. As a result, different types of feature extractions and classifiers have been employed to evaluate the accuracy of frog sound identification. This paper presents a frog sound identification with Extended k-Nearest Neighbor (EKNN) classifier. The EKNN classifier integrates the nearest neighbors and mutual sharing of neighborhood concepts, with the aims of improving the classification performance. It makes a prediction based on who are the nearest neighbors of the testing sample and who consider the testing sample as their nearest neighbors. In order to evaluate the classification performance in frog sound identification, the EKNN classifier is compared with competing classifier, k -Nearest Neighbor (KNN), Fuzzy k -Nearest Neighbor (FKNN) k - General Nearest Neighbor (KGNN)and Mutual k -Nearest Neighbor (MKNN) on the recorded sounds of 15 frog species obtained in Malaysia forest. The recorded sounds have been segmented using Short Time Energy and Short Time Average Zero Crossing Rate (STE+STAZCR), sinusoidal modeling (SM), manual and the combination of Energy (E) and Zero Crossing Rate (ZCR) (E+ZCR) while the features are extracted by Mel Frequency Cepstrum Coefficient (MFCC). The experimental results have shown that the EKNCN classifier exhibits the best performance in terms of accuracy compared to the competing classifiers, KNN, FKNN, GKNN and MKNN for all cases.

  9. On the Complexity of Inner Product Similarity Join

    DEFF Research Database (Denmark)

    Ahle, Thomas Dybdahl; Pagh, Rasmus; Razenshteyn, Ilya

    2016-01-01

    A number of tasks in classification, information retrieval, recommendation systems, and record linkage reduce to the core problem of inner product similarity join (IPS join): identifying pairs of vectors in a collection that have a sufficiently large inner product. IPS join is well understood when...... bounds for (A)LSH-based algorithms. In particular, we show that asymmetry can be avoided by relaxing the LSH definition to only consider the collision probability of distinct elements. A new indexing method for IPS based on linear sketches, implying that our hardness results are not far from being tight...

  10. Generic multiset programming with discrimination-based joins and symbolic Cartesian products

    DEFF Research Database (Denmark)

    Henglein, Fritz; Larsen, Ken Friis

    2010-01-01

    This paper presents GMP, a library for generic, SQL-style programming with multisets. It generalizes the querying core of SQL in a number of ways: Multisets may contain elements of arbitrary first-order data types, including references (pointers), recur- sive data types and nested multisets......: symbolic (term) repre- sentations of multisets, specifically for Cartesian products, for facilitating dynamic symbolic computation, which intersperses algebraic simplification steps with conventional data pro- cessing; and discrimination-based joins, a generic technique for computing equijoins based...

  11. Efficient string similarity join in multi-core and distributed systems.

    Directory of Open Access Journals (Sweden)

    Cairong Yan

    Full Text Available In big data area a significant challenge about string similarity join is to find all similar pairs more efficiently. In this paper, we propose a parallel processing framework for efficient string similarity join. First, the input is split into some disjoint small subsets according to the joint frequency distribution and the interval distribution of strings. Then the filter-verification strategy is adopted in the computation of string similarity for each subset so that the number of candidate pairs is reduced before an effective pruning strategy is used to improve the performance. Finally, the operation of string join is executed in parallel. Para-Join algorithm based on the multi-threading technique is proposed to implement the framework in a multi-core system while Pada-Join algorithm based on Spark platform is proposed to implement the framework in a cluster system. We prove that Para-Join and Pada-Join cannot only avoid reduplicate computation but also ensure the completeness of the result. Experimental results show that Para-Join can achieve high efficiency and significantly outperform than state-of-the-art approaches, meanwhile, Pada-Join can work on large datasets.

  12. Conjoint Forming - Technologies for Simultaneous Forming and Joining

    International Nuclear Information System (INIS)

    Groche, P; Wohletz, S; Mann, A; Krech, M; Monnerjahn, V

    2016-01-01

    The market demand for new products optimized for e. g. lightweight applications or smart components leads to new challenges in production engineering. Hybrid structures represent one promising approach. They aim at higher product performance by using a suitable combination of different materials. The developments of hybrid structures stimulate the research on joining of dissimilar materials. Since they allow for joining dissimilar materials without external heating technologies based on joining by plastic deformation seem to be of special attractiveness. The paper at hand discusses the conjoint forming approach. This approach combines forming and joining in one process. Two or more workpieces are joined while at least one workpiece is plastically deformed. After presenting the fundamental joining mechanisms, the conjoint forming approach is discussed comprehensively. Examples of conjoint processes demonstrate the effectiveness and reveal the underlying phenomena. (paper)

  13. Morphological characterization and phylogenetic distance among ...

    African Journals Online (AJOL)

    The genetic diversity was calculated with Nei and Li's index, and the phylogenetic tree (dendrogram) was generated with a neighbor-joining program. The dendrogram indicates the diversity of the genotypes, which are grouped into three distinctive large groups. The largest group includes species from the Mediolobivia and ...

  14. Genotypic and phenotypic diversity among Bacillus species isolated ...

    African Journals Online (AJOL)

    DIRECTOR

    2013-03-20

    Mar 20, 2013 ... (GQ911556), B. weihenstephanensis DSM 11821T (AJ841876), B. mycoides ATCC 6462T (AB021192) and Brevibacillus brevis 1393. (AB271756). The evolutionary history was inferred using the. Neighbor-Joining method (Saitou and Nei, 1987). The percentage of replicate trees in which the associated ...

  15. Multi-weighted tree based query optimization method for parallel relational database systems%基于多重加权树的并行关系数据库系统的查询优化方法

    Institute of Scientific and Technical Information of China (English)

    2001-01-01

    The author investigates the query optimization problem for parallel relational databases. A multi-weighted tree based query optimization method is proposed. The method consists of a multi-weighted tree based parallel query plan model, a cost model for parallel qury plans and a query optimizer. The parallel query plan model is the first one to model all basic relational operations, all three types of parallelism of query execution, processor and memory allocation to operations, memory allocation to the buffers between operations in pipelines and data redistribution among processors.The cost model takes the waiting time of the operations in pipelining execution into consideration and is computable in a bottom-up fashion. The query optimizer addresses the query optimization problem in the context of Select-Project-Join queries that are widely used in commercial DBMSs. Several heuristics determining the processor allocation to operations are derived and used in the query optimizer. The query optimizer is aware of memory resources in order to generate good-quality plans. It includes the heuristics for determining the memory allocation to operations and buffers between operations in pipelines so that the memory resourse is fully exploit. In addition, multiple algorithms for implementing join operations are consided in the query optimizer. The query optimizer can make an optimal choice of join algorithm for each join operation in a query. The proposed query optimization method has been used in a prototype parallel database management system designed and implemented by the author.

  16. A Modeling Approach for Plastic-Metal Laser Direct Joining

    Science.gov (United States)

    Lutey, Adrian H. A.; Fortunato, Alessandro; Ascari, Alessandro; Romoli, Luca

    2017-09-01

    Laser processing has been identified as a feasible approach to direct joining of metal and plastic components without the need for adhesives or mechanical fasteners. The present work sees development of a modeling approach for conduction and transmission laser direct joining of these materials based on multi-layer optical propagation theory and numerical heat flow simulation. The scope of this methodology is to predict process outcomes based on the calculated joint interface and upper surface temperatures. Three representative cases are considered for model verification, including conduction joining of PBT and aluminum alloy, transmission joining of optically transparent PET and stainless steel, and transmission joining of semi-transparent PA 66 and stainless steel. Conduction direct laser joining experiments are performed on black PBT and 6082 anticorodal aluminum alloy, achieving shear loads of over 2000 N with specimens of 2 mm thickness and 25 mm width. Comparison with simulation results shows that consistently high strength is achieved where the peak interface temperature is above the plastic degradation temperature. Comparison of transmission joining simulations and published experimental results confirms these findings and highlights the influence of plastic layer optical absorption on process feasibility.

  17. Tree-Based Unrooted Phylogenetic Networks.

    Science.gov (United States)

    Francis, A; Huber, K T; Moulton, V

    2018-02-01

    Phylogenetic networks are a generalization of phylogenetic trees that are used to represent non-tree-like evolutionary histories that arise in organisms such as plants and bacteria, or uncertainty in evolutionary histories. An unrooted phylogenetic network on a non-empty, finite set X of taxa, or network, is a connected, simple graph in which every vertex has degree 1 or 3 and whose leaf set is X. It is called a phylogenetic tree if the underlying graph is a tree. In this paper we consider properties of tree-based networks, that is, networks that can be constructed by adding edges into a phylogenetic tree. We show that although they have some properties in common with their rooted analogues which have recently drawn much attention in the literature, they have some striking differences in terms of both their structural and computational properties. We expect that our results could eventually have applications to, for example, detecting horizontal gene transfer or hybridization which are important factors in the evolution of many organisms.

  18. Estimating Stand Height and Tree Density in Pinus taeda plantations using in-situ data, airborne LiDAR and k-Nearest Neighbor Imputation

    Directory of Open Access Journals (Sweden)

    CARLOS ALBERTO SILVA

    Full Text Available ABSTRACT Accurate forest inventory is of great economic importance to optimize the entire supply chain management in pulp and paper companies. The aim of this study was to estimate stand dominate and mean heights (HD and HM and tree density (TD of Pinus taeda plantations located in South Brazil using in-situ measurements, airborne Light Detection and Ranging (LiDAR data and the non- k-nearest neighbor (k-NN imputation. Forest inventory attributes and LiDAR derived metrics were calculated at 53 regular sample plots and we used imputation models to retrieve the forest attributes at plot and landscape-levels. The best LiDAR-derived metrics to predict HD, HM and TD were H99TH, HSD, SKE and HMIN. The Imputation model using the selected metrics was more effective for retrieving height than tree density. The model coefficients of determination (adj.R2 and a root mean squared difference (RMSD for HD, HM and TD were 0.90, 0.94, 0.38m and 6.99, 5.70, 12.92%, respectively. Our results show that LiDAR and k-NN imputation can be used to predict stand heights with high accuracy in Pinus taeda. However, furthers studies need to be realized to improve the accuracy prediction of TD and to evaluate and compare the cost of acquisition and processing of LiDAR data against the conventional inventory procedures.

  19. Spatial correlations between browsing on balsam fir by white-tailed deer and the nutritional value of neighboring winter forage.

    Science.gov (United States)

    Champagne, Emilie; Moore, Ben D; Côté, Steeve D; Tremblay, Jean-Pierre

    2018-03-01

    Associational effects, that is, the influence of neighboring plants on herbivory suffered by a plant, are an outcome of forage selection. Although forage selection is a hierarchical process, few studies have investigated associational effects at multiple spatial scales. Because the nutritional quality of plants can be spatially structured, it might differently influence associational effects across multiple scales. Our objective was to determine the radius of influence of neighbor density and nutritional quality on balsam fir ( Abies balsamea ) herbivory by white-tailed deer ( Odocoileus virginianus ) in winter. We quantified browsing rates on fir and the density and quality of neighboring trees in a series of 10-year-old cutovers on Anticosti Island (Canada). We used cross-correlations to investigate relationships between browsing rates and the density and nutritional quality of neighboring trees at distances up to 1,000 m. Balsam fir and white spruce ( Picea glauca ) fiber content and dry matter in vitro true digestibility were correlated with fir browsing rate at the finest extra-patch scale (across distance of up to 50 m) and between cutover areas (300-400 m). These correlations suggest associational effects, that is, low nutritional quality of neighbors reduces the likelihood of fir herbivory (associational defense). Our results may indicate associational effects mediated by intraspecific variation in plant quality and suggest that these effects could occur at scales from tens to hundreds of meters. Understanding associational effects could inform strategies for restoration or conservation; for example, planting of fir among existing natural regeneration could be concentrated in areas of low nutritional quality.

  20. Nearest neighbor 3D segmentation with context features

    Science.gov (United States)

    Hristova, Evelin; Schulz, Heinrich; Brosch, Tom; Heinrich, Mattias P.; Nickisch, Hannes

    2018-03-01

    Automated and fast multi-label segmentation of medical images is challenging and clinically important. This paper builds upon a supervised machine learning framework that uses training data sets with dense organ annotations and vantage point trees to classify voxels in unseen images based on similarity of binary feature vectors extracted from the data. Without explicit model knowledge, the algorithm is applicable to different modalities and organs, and achieves high accuracy. The method is successfully tested on 70 abdominal CT and 42 pelvic MR images. With respect to ground truth, an average Dice overlap score of 0.76 for the CT segmentation of liver, spleen and kidneys is achieved. The mean score for the MR delineation of bladder, bones, prostate and rectum is 0.65. Additionally, we benchmark several variations of the main components of the method and reduce the computation time by up to 47% without significant loss of accuracy. The segmentation results are - for a nearest neighbor method - surprisingly accurate, robust as well as data and time efficient.

  1. Marbled Murrelets Select Distinctive Nest Trees within Old-Growth Forest Patches

    Directory of Open Access Journals (Sweden)

    Michael P. Silvergieter

    2011-12-01

    Full Text Available The coastal old-growth forests of North America's Pacific Coast are renowned both for their commercial and ecological value. This study adds to growing evidence that selective harvesting of the largest trees may have a disproportionate ecological impact. Marbled Murrelets (Brachyramphus marmoratus, a threatened species, nest almost exclusively in these old-growth forests. Detailed knowledge of nesting habitat selection provides guidance for habitat management and conservation. Habitat selection for this species has been studied at a variety of scales using ground and remote methods. However, because Marbled Murrelet nesting activity is limited to a single mossy platform on a single tree, we investigated nest tree selection within old-growth forest patches, using a set of 59 forest patches containing active nests. Nest trees were usually distinctive compared with neighboring trees in the surrounding 25 m radius patch. They averaged 15 to 20% taller than neighboring trees depending on region, had significantly larger stem diameters, more potential nesting platforms, and more moss. They had the most extreme values of height and width about three times as often as expected by chance. An analysis of moss platform use as a function of number of platforms per platform tree suggests that murrelets select individual platforms, rather than platform trees per se. Nonetheless, highly selective logging practices that remove high-value trees from stands may also remove trees most likely to be selected by nesting murrelets.

  2. Improving Recommendations in Tag-based Systems with Spectral Clustering of Tag Neighbors

    DEFF Research Database (Denmark)

    Pan, Rong; Xu, Guandong; Dolog, Peter

    2012-01-01

    Tag as a useful metadata reflects the collaborative and conceptual features of documents in social collaborative annotation systems. In this paper, we propose a collaborative approach for expanding tag neighbors and investigate the spectral clustering algorithm to filter out noisy tag neighbors...... in order to get appropriate recommendation for users. The preliminary experiments have been conducted on MovieLens dataset to compare our proposed approach with the traditional collaborative filtering recommendation approach and naive tag neighbors expansion approach in terms of precision, and the result...... demonstrates that our approach could considerably improve the performance of recommendations....

  3. Nearest neighbor imputation using spatial-temporal correlations in wireless sensor networks.

    Science.gov (United States)

    Li, YuanYuan; Parker, Lynne E

    2014-01-01

    Missing data is common in Wireless Sensor Networks (WSNs), especially with multi-hop communications. There are many reasons for this phenomenon, such as unstable wireless communications, synchronization issues, and unreliable sensors. Unfortunately, missing data creates a number of problems for WSNs. First, since most sensor nodes in the network are battery-powered, it is too expensive to have the nodes retransmit missing data across the network. Data re-transmission may also cause time delays when detecting abnormal changes in an environment. Furthermore, localized reasoning techniques on sensor nodes (such as machine learning algorithms to classify states of the environment) are generally not robust enough to handle missing data. Since sensor data collected by a WSN is generally correlated in time and space, we illustrate how replacing missing sensor values with spatially and temporally correlated sensor values can significantly improve the network's performance. However, our studies show that it is important to determine which nodes are spatially and temporally correlated with each other. Simple techniques based on Euclidean distance are not sufficient for complex environmental deployments. Thus, we have developed a novel Nearest Neighbor (NN) imputation method that estimates missing data in WSNs by learning spatial and temporal correlations between sensor nodes. To improve the search time, we utilize a k d-tree data structure, which is a non-parametric, data-driven binary search tree. Instead of using traditional mean and variance of each dimension for k d-tree construction, and Euclidean distance for k d-tree search, we use weighted variances and weighted Euclidean distances based on measured percentages of missing data. We have evaluated this approach through experiments on sensor data from a volcano dataset collected by a network of Crossbow motes, as well as experiments using sensor data from a highway traffic monitoring application. Our experimental

  4. Joining of advanced materials

    CERN Document Server

    Messler, Robert W

    1993-01-01

    Provides an unusually complete and readable compilation of the primary and secondary options for joining conventional materials in non-conventional ways. Provides unique coverage of adhesive bonding using both organic and inorganic adhesives, cements and mortars. Focuses on materials issues without ignoring issues related to joint design, production processing, quality assurance, process economics, and joining performance in service.Joining of advanced materials is a unique treatment of joining of both conventional and advanced metals andalloys, intermetallics, ceramics, glasses, polymers, a

  5. Robust B+ -Tree-Based Indexing of Moving Objects

    DEFF Research Database (Denmark)

    Jensen, Christian Søndergaard; Tiesyte, Dalia; Tradisauskas, Nerius

    2006-01-01

    Bx-tree is based on the B+-tree and is relatively easy to integrate into an existing DBMS. However, the Bx-tree is sensitive to data skew. This paper proposes a new query processing algorithm for the Bx-tree that fully exploits the available data statistics to reduce the query enlargement...

  6. Joining by plastic deformation

    DEFF Research Database (Denmark)

    Mori, Ken-ichiro; Bay, Niels; Fratini, Livan

    2013-01-01

    As the scale and complexity of products such as aircraft and cars increase, demand for new functional processes to join mechanical parts grows. The use of plastic deformation for joining parts potentially offers improved accuracy, reliability and environmental safety as well as creating opportuni......As the scale and complexity of products such as aircraft and cars increase, demand for new functional processes to join mechanical parts grows. The use of plastic deformation for joining parts potentially offers improved accuracy, reliability and environmental safety as well as creating...

  7. Ceramic joining

    Energy Technology Data Exchange (ETDEWEB)

    Loehman, R.E. [Sandia National Lab., Albuquerque, NM (United States)

    1996-04-01

    This paper describes the relation between reactions at ceramic-metal interfaces and the development of strong interfacial bonds in ceramic joining. Studies on a number of systems are described, including silicon nitrides, aluminium nitrides, mullite, and aluminium oxides. Joints can be weakened by stresses such as thermal expansion mismatch. Ceramic joining is used in a variety of applications such as solid oxide fuel cells.

  8. The Problem of Predecessors on Spanning Trees

    Directory of Open Access Journals (Sweden)

    V. S. Poghosyan

    2011-01-01

    Full Text Available We consider the equiprobable distribution of spanning trees on the square lattice. All bonds of each tree can be oriented uniquely with respect to an arbitrary chosen site called the root. The problem of predecessors is to find the probability that a path along the oriented bonds passes sequentially fixed sites i and j. The conformal field theory for the Potts model predicts the fractal dimension of the path to be 5/4. Using this result, we show that the probability in the predecessors problem for two sites separated by large distance r decreases as P(r ∼ r −3/4. If sites i and j are nearest neighbors on the square lattice, the probability P(1 = 5/16 can be found from the analytical theory developed for the sandpile model. The known equivalence between the loop erased random walk (LERW and the directed path on the spanning tree states that P(1 is the probability for the LERW started at i to reach the neighboring site j. By analogy with the self-avoiding walk, P(1 can be called the return probability. Extensive Monte-Carlo simulations confirm the theoretical predictions.

  9. Taxonomic relationships among Phenacomys voles as inferred by cytochrome b

    Science.gov (United States)

    Bellinger, M.R.; Haig, S.M.; Forsman, E.D.; Mullins, T.D.

    2005-01-01

    Taxonomic relationships among red tree voles (Phenacomys longicaudus longicaudus, P. l. silvicola), the Sonoma tree vole (P. pomo), the white-footed vole (P. albipes), and the heather vole (P. intermedius) were examined using 664 base pairs of the mitochondrial cytochrome b gene. Results indicate specific differences among red tree voles, Sonoma tree voles, white-footed voles, and heather voles, but no clear difference between the 2 Oregon subspecies of red tree voles (P. l. longicaudus and P. l. silvicola). Our data further indicated a close relationship between tree voles and albipes, validating inclusion of albipes in the subgenus Arborimus. These 3 congeners shared a closer relationship to P. intermedius than to other arvicolids. A moderate association between porno and albipes was indicated by maximum parsimony and neighbor-joining phylogenetic analyses. Molecular clock estimates suggest a Pleistocene radiation of the Arborimus clade, which is concordant with pulses of diversification observed in other murid rodents. The generic rank of Arborimus is subject to interpretation of data.

  10. An Injection with Tree Awareness : Adding Staircase Join to PostgreSQL

    NARCIS (Netherlands)

    Mayer, Sabine; Grust, Torsten; van Keulen, Maurice; Teubner, Jens

    The syntactic wellformedness constraints of XML (opening and closing tags nest properly) imply that XML processors face the challenge to efficiently handle data that takes the shape of ordered, unranked trees. Although RDBMSs have originally been designed to manage table-shaped data, we propose

  11. Base tree property

    Czech Academy of Sciences Publication Activity Database

    Balcar, B.; Doucha, Michal; Hrušák, M.

    2015-01-01

    Roč. 32, č. 1 (2015), s. 69-81 ISSN 0167-8094 R&D Projects: GA AV ČR IAA100190902 Institutional support: RVO:67985840 Keywords : forcing * Boolean algebras * base tree Subject RIV: BA - General Mathematics Impact factor: 0.614, year: 2015 http://link.springer.com/article/10.1007/s11083-013-9316-2

  12. Species-Level Para- and Polyphyly in DNA Barcode Gene Trees: Strong Operational Bias in European Lepidoptera.

    Science.gov (United States)

    Mutanen, Marko; Kivelä, Sami M; Vos, Rutger A; Doorenweerd, Camiel; Ratnasingham, Sujeevan; Hausmann, Axel; Huemer, Peter; Dincă, Vlad; van Nieukerken, Erik J; Lopez-Vaamonde, Carlos; Vila, Roger; Aarvik, Leif; Decaëns, Thibaud; Efetov, Konstantin A; Hebert, Paul D N; Johnsen, Arild; Karsholt, Ole; Pentinsaari, Mikko; Rougerie, Rodolphe; Segerer, Andreas; Tarmann, Gerhard; Zahiri, Reza; Godfray, H Charles J

    2016-11-01

    The proliferation of DNA data is revolutionizing all fields of systematic research. DNA barcode sequences, now available for millions of specimens and several hundred thousand species, are increasingly used in algorithmic species delimitations. This is complicated by occasional incongruences between species and gene genealogies, as indicated by situations where conspecific individuals do not form a monophyletic cluster in a gene tree. In two previous reviews, non-monophyly has been reported as being common in mitochondrial DNA gene trees. We developed a novel web service "Monophylizer" to detect non-monophyly in phylogenetic trees and used it to ascertain the incidence of species non-monophyly in COI (a.k.a. cox1) barcode sequence data from 4977 species and 41,583 specimens of European Lepidoptera, the largest data set of DNA barcodes analyzed from this regard. Particular attention was paid to accurate species identification to ensure data integrity. We investigated the effects of tree-building method, sampling effort, and other methodological issues, all of which can influence estimates of non-monophyly. We found a 12% incidence of non-monophyly, a value significantly lower than that observed in previous studies. Neighbor joining (NJ) and maximum likelihood (ML) methods yielded almost equal numbers of non-monophyletic species, but 24.1% of these cases of non-monophyly were only found by one of these methods. Non-monophyletic species tend to show either low genetic distances to their nearest neighbors or exceptionally high levels of intraspecific variability. Cases of polyphyly in COI trees arising as a result of deep intraspecific divergence are negligible, as the detected cases reflected misidentifications or methodological errors. Taking into consideration variation in sampling effort, we estimate that the true incidence of non-monophyly is ∼23%, but with operational factors still being included. Within the operational factors, we separately assessed the

  13. NeighborHood

    OpenAIRE

    Corominola Ocaña, Víctor

    2015-01-01

    NeighborHood és una aplicació basada en el núvol, adaptable a qualsevol dispositiu (mòbil, tablet, desktop). L'objectiu d'aquesta aplicació és poder permetre als usuaris introduir a les persones del seu entorn més immediat i que aquestes persones siguin visibles per a la resta d'usuaris. NeighborHood es una aplicación basada en la nube, adaptable a cualquier dispositivo (móvil, tablet, desktop). El objetivo de esta aplicación es poder permitir a los usuarios introducir a las personas de su...

  14. Comparison of Boolean analysis and standard phylogenetic methods using artificially evolved and natural mt-tRNA sequences from great apes.

    Science.gov (United States)

    Ari, Eszter; Ittzés, Péter; Podani, János; Thi, Quynh Chi Le; Jakó, Eena

    2012-04-01

    Boolean analysis (or BOOL-AN; Jakó et al., 2009. BOOL-AN: A method for comparative sequence analysis and phylogenetic reconstruction. Mol. Phylogenet. Evol. 52, 887-97.), a recently developed method for sequence comparison uses the Iterative Canonical Form of Boolean functions. It considers sequence information in a way entirely different from standard phylogenetic methods (i.e. Maximum Parsimony, Maximum-Likelihood, Neighbor-Joining, and Bayesian analysis). The performance and reliability of Boolean analysis were tested and compared with the standard phylogenetic methods, using artificially evolved - simulated - nucleotide sequences and the 22 mitochondrial tRNA genes of the great apes. At the outset, we assumed that the phylogeny of Hominidae is generally well established, and the guide tree of artificial sequence evolution can also be used as a benchmark. These offer a possibility to compare and test the performance of different phylogenetic methods. Trees were reconstructed by each method from 2500 simulated sequences and 22 mitochondrial tRNA sequences. We also introduced a special re-sampling method for Boolean analysis on permuted sequence sites, the P-BOOL-AN procedure. Considering the reliability values (branch support values of consensus trees and Robinson-Foulds distances) we used for simulated sequence trees produced by different phylogenetic methods, BOOL-AN appeared as the most reliable method. Although the mitochondrial tRNA sequences of great apes are relatively short (59-75 bases long) and the ratio of their constant characters is about 75%, BOOL-AN, P-BOOL-AN and the Bayesian approach produced the same tree-topology as the established phylogeny, while the outcomes of Maximum Parsimony, Maximum-Likelihood and Neighbor-Joining methods were equivocal. We conclude that Boolean analysis is a promising alternative to existing methods of sequence comparison for phylogenetic reconstruction and congruence analysis. Copyright © 2012 Elsevier Inc. All

  15. Late summer temperature reconstruction based on tree-ring density for Sygera Mountain, southeastern Tibetan Plateau

    Science.gov (United States)

    Li, Mingyong; Duan, Jianping; Wang, Lily; Zhu, Haifeng

    2018-04-01

    Although several tree-ring density-based summer/late summer temperature reconstructions have been developed on the Tibetan Plateau (TP), the understanding of the local/regional characteristics of summer temperature fluctuations on a long-term scale in some regions is still limited. To improve our understanding in these aspects, more local or regional summer temperature reconstructions extending back over several centuries are required. In this study, a new mean latewood density (LWD) chronology from Abies georgei var. smithii from the upper tree line of Sygera Mountain on the southeastern TP was developed to reconstruct the late summer temperature variability since 1820 CE. The bootstrapped correlation analysis showed that the LWD chronology index was significantly and positively correlated with the late summer (August-September) mean temperatures (r1950-2008 = 0.63, p < 0.001) recorded at the nearest meteorological station and that this reconstruction has considerable potential to represent the late summer temperature variability at the regional scale. Our late summer temperature reconstruction revealed three obvious cold periods (i.e., 1872-1908, 1913-1937 and 1941-1966) and two relatively warm phases (i.e., 1821-1871 and 1970-2008) over the past two centuries. Comparisons of our reconstruction with other independent tree-ring-based temperature reconstructions, glacier fluctuations and historical documental records from neighboring regions showed good agreement in these relatively cold and warm intervals. Our reconstruction exhibits an overall increasing temperature trend since the 1960s, providing new evidence supporting the recent warming of the TP. Moreover, our results also indicate that the late summer temperature variability of Sygera Mountain on the southeastern TP has potential links with the Pacific Decadal Oscillation (PDO).

  16. Multiple sequence alignment accuracy and phylogenetic inference.

    Science.gov (United States)

    Ogden, T Heath; Rosenberg, Michael S

    2006-04-01

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

  17. Quantum Algorithm for K-Nearest Neighbors Classification Based on the Metric of Hamming Distance

    Science.gov (United States)

    Ruan, Yue; Xue, Xiling; Liu, Heng; Tan, Jianing; Li, Xi

    2017-11-01

    K-nearest neighbors (KNN) algorithm is a common algorithm used for classification, and also a sub-routine in various complicated machine learning tasks. In this paper, we presented a quantum algorithm (QKNN) for implementing this algorithm based on the metric of Hamming distance. We put forward a quantum circuit for computing Hamming distance between testing sample and each feature vector in the training set. Taking advantage of this method, we realized a good analog for classical KNN algorithm by setting a distance threshold value t to select k - n e a r e s t neighbors. As a result, QKNN achieves O( n 3) performance which is only relevant to the dimension of feature vectors and high classification accuracy, outperforms Llyod's algorithm (Lloyd et al. 2013) and Wiebe's algorithm (Wiebe et al. 2014).

  18. Section-Based Tree Species Identification Using Airborne LIDAR Point Cloud

    Science.gov (United States)

    Yao, C.; Zhang, X.; Liu, H.

    2017-09-01

    The application of LiDAR data in forestry initially focused on mapping forest community, particularly and primarily intended for largescale forest management and planning. Then with the smaller footprint and higher sampling density LiDAR data available, detecting individual tree overstory, estimating crowns parameters and identifying tree species are demonstrated practicable. This paper proposes a section-based protocol of tree species identification taking palm tree as an example. Section-based method is to detect objects through certain profile among different direction, basically along X-axis or Y-axis. And this method improve the utilization of spatial information to generate accurate results. Firstly, separate the tree points from manmade-object points by decision-tree-based rules, and create Crown Height Mode (CHM) by subtracting the Digital Terrain Model (DTM) from the digital surface model (DSM). Then calculate and extract key points to locate individual trees, thus estimate specific tree parameters related to species information, such as crown height, crown radius, and cross point etc. Finally, with parameters we are able to identify certain tree species. Comparing to species information measured on ground, the portion correctly identified trees on all plots could reach up to 90.65 %. The identification result in this research demonstrate the ability to distinguish palm tree using LiDAR point cloud. Furthermore, with more prior knowledge, section-based method enable the process to classify trees into different classes.

  19. Tree Regeneration Spatial Patterns in Ponderosa Pine Forests Following Stand-Replacing Fire: Influence of Topography and Neighbors

    Directory of Open Access Journals (Sweden)

    Justin P. Ziegler

    2017-10-01

    Full Text Available Shifting fire regimes alter forest structure assembly in ponderosa pine forests and may produce structural heterogeneity following stand-replacing fire due, in part, to fine-scale variability in growing environments. We mapped tree regeneration in eighteen plots 11 to 15 years after stand-replacing fire in Colorado and South Dakota, USA. We used point pattern analyses to examine the spatial pattern of tree locations and heights as well as the influence of tree interactions and topography on tree patterns. In these sparse, early-seral forests, we found that all species were spatially aggregated, partly attributable to the influence of (1 aspect and slope on conifers; (2 topographic position on quaking aspen; and (3 interspecific attraction between ponderosa pine and other species. Specifically, tree interactions were related to finer-scale patterns whereas topographic effects influenced coarse-scale patterns. Spatial structures of heights revealed conspecific size hierarchies with taller trees in denser neighborhoods. Topography and heterospecific tree interactions had nominal effect on tree height spatial structure. Our results demonstrate how stand-replacing fires create heterogeneous forest structures and suggest that scale-dependent, and often facilitatory, rather than competitive, processes act on regenerating trees. These early-seral processes will establish potential pathways of stand development, affecting future forest dynamics and management options.

  20. Secure Nearest Neighbor Query on Crowd-Sensing Data

    Directory of Open Access Journals (Sweden)

    Ke Cheng

    2016-09-01

    Full Text Available Nearest neighbor queries are fundamental in location-based services, and secure nearest neighbor queries mainly focus on how to securely and quickly retrieve the nearest neighbor in the outsourced cloud server. However, the previous big data system structure has changed because of the crowd-sensing data. On the one hand, sensing data terminals as the data owner are numerous and mistrustful, while, on the other hand, in most cases, the terminals find it difficult to finish many safety operation due to computation and storage capability constraints. In light of they Multi Owners and Multi Users (MOMU situation in the crowd-sensing data cloud environment, this paper presents a secure nearest neighbor query scheme based on the proxy server architecture, which is constructed by protocols of secure two-party computation and secure Voronoi diagram algorithm. It not only preserves the data confidentiality and query privacy but also effectively resists the collusion between the cloud server and the data owners or users. Finally, extensive theoretical and experimental evaluations are presented to show that our proposed scheme achieves a superior balance between the security and query performance compared to other schemes.

  1. Coalescent-based species tree inference from gene tree topologies under incomplete lineage sorting by maximum likelihood.

    Science.gov (United States)

    Wu, Yufeng

    2012-03-01

    Incomplete lineage sorting can cause incongruence between the phylogenetic history of genes (the gene tree) and that of the species (the species tree), which can complicate the inference of phylogenies. In this article, I present a new coalescent-based algorithm for species tree inference with maximum likelihood. I first describe an improved method for computing the probability of a gene tree topology given a species tree, which is much faster than an existing algorithm by Degnan and Salter (2005). Based on this method, I develop a practical algorithm that takes a set of gene tree topologies and infers species trees with maximum likelihood. This algorithm searches for the best species tree by starting from initial species trees and performing heuristic search to obtain better trees with higher likelihood. This algorithm, called STELLS (which stands for Species Tree InfErence with Likelihood for Lineage Sorting), has been implemented in a program that is downloadable from the author's web page. The simulation results show that the STELLS algorithm is more accurate than an existing maximum likelihood method for many datasets, especially when there is noise in gene trees. I also show that the STELLS algorithm is efficient and can be applied to real biological datasets. © 2011 The Author. Evolution© 2011 The Society for the Study of Evolution.

  2. JOINING DISSIMILAR MATERIALS USING FRICTION STIR SCRIBE TECHNIQUE

    Energy Technology Data Exchange (ETDEWEB)

    Upadhyay, Piyush; Hovanski, Yuri; Jana, Saumyadeep; Fifield, Leonard S.

    2016-09-01

    Development of robust and cost effective method of joining dissimilar materials can provide a critical pathway to enable widespread use of multi-material design and components in mainstream industrial applications. The use of multi-material components such as Steel-Aluminum, Aluminum-Polymer allows design engineers to optimize material utilization based on service requirements and often lead weight and cost reductions. However producing an effective joint between materials with vastly different thermal, microstructural and deformation response is highly problematic using conventional joining and /or fastening methods. This is especially challenging in cost sensitive high volume markets that largely rely on low–cost joining solutions. Friction Stir Scribe technology was developed to meet the demands of joining materials with drastically different properties and melting regimes. The process enables joining of light metals like Magnesium and Aluminum to high temperature materials like Steels and Titanium. Additionally viable joints between polymer composites and metal can also be made using this method. This paper will present state of the art, progress made and challenges associated with this innovative derivative of Friction Stir welding in reference to joining dissimilar metals and polymer/metal combinations.

  3. Joining Dissimilar Materials Using Friction Stir Scribe Technique

    Energy Technology Data Exchange (ETDEWEB)

    Upadhyay, Piyush [Pacific Northwest National Laboratory, Richland 99352, WA e-mail: piyush.upadhyay@pnnl.gov; Hovanski, Yuri [Pacific Northwest National Laboratory, Richland 99352, WA; Jana, Saumyadeep [Pacific Northwest National Laboratory, Richland 99352, WA; Fifield, Leonard S. [Pacific Northwest National Laboratory, Richland 99352, WA

    2016-10-03

    Development of a robust and cost-effective method of joining dissimilar materials could provide a critical pathway to enable widespread use of multi-material designs and components in mainstream industrial applications. The use of multi-material components such as steel-aluminum and aluminum-polymer would allow design engineers to optimize material utilization based on service requirements and could often lead to weight and cost reductions. However, producing an effective joint between materials with vastly different thermal, microstructural, and deformation responses is highly problematic using conventional joining and/or fastening methods. This is especially challenging in cost sensitive, high volume markets that largely rely on low cost joining solutions. Friction stir scribe technology was developed to meet the demands of joining materials with drastically different properties and melting regimes. The process enables joining of light metals like magnesium and aluminum to high temperature materials like steel and titanium. Viable joints between polymer composites and metal can also be made using this method. This paper will present the state of the art, progress made, and challenges associated with this innovative derivative of friction stir welding in reference to joining dissimilar metals and polymer/metal combinations.

  4. Chrysler Upset Protrusion Joining Techniques for Joining Dissimilar Metals

    Energy Technology Data Exchange (ETDEWEB)

    Logan, Stephen [FCA US LLC, Auburn Hills, MI (United States)

    2017-09-28

    The project goal was to develop and demonstrate a robust, cost effective, and versatile joining technique, known as Upset Protrusion Joining (UPJ), for joining challenging dissimilar metal com-binations, especially those where one of the metals is a die cast magnesium (Mg) component. Since two of the key obstacles preventing more widespread use of light metals (especially in high volume automotive applications) are 1) a lack of robust joining techniques and 2) susceptibility to galvanic corrosion, and since the majority of the joint combinations evaluated in this project include die cast Mg (the lightest structural metal) as one of the two materials being joined, and since die casting is the most common and cost effective process for producing Mg components, then successful project completion provides a key enabler to high volume application of lightweight materials, thus potentially leading to reduced costs, and encouraging implementation of lightweight multi-material vehicles for significant reductions in energy consumption and reduced greenhouse gas emissions. Eco-nomic benefits to end-use consumers are achieved primarily via the reduction in fuel consumption. Unlike currently available commercial processes, the UPJ process relies on a very robust mechanical joint rather than intermetallic bonding, so the more cathodic material can be coated prior to joining, thus creating a robust isolation against galvanic attack on the more anodic material. Additionally, since the UPJ protrusion is going through a hole that can be pre-drilled or pre-punched prior to coating, the UPJ process is less likely to damage the coating when the joint is being made. Further-more, since there is no additional cathodic material (such as a steel fastener) used to create the joint, there is no joining induced galvanic activity beyond that of the two parent materials. In accordance with its originally proposed plan, this project has successfully developed process variants of UPJ to enable

  5. Neighboring and Urbanism: Commonality versus Friendship.

    Science.gov (United States)

    Silverman, Carol J.

    1986-01-01

    Examines a dimension of neighboring that need not assume friendship as the role model. When the model assumes only a sense of connectedness as defining neighboring, then the residential correlation, shown in many studies between urbanism and neighboring, disappears. Theories of neighboring, study variables, methods, and analysis are discussed.…

  6. Join Operations in Temporal Databases

    DEFF Research Database (Denmark)

    Gao, D.; Jensen, Christian Søndergaard; Snodgrass, R.T.

    2005-01-01

    Joins are arguably the most important relational operators. Poor implementations are tantamount to computing the Cartesian product of the input relations. In a temporal database, the problem is more acute for two reasons. First, conventional techniques are designed for the evaluation of joins...... with equality predicates rather than the inequality predicates prevalent in valid-time queries. Second, the presence of temporally varying data dramatically increases the size of a database. These factors indicate that specialized techniques are needed to efficiently evaluate temporal joins. We address...... this need for efficient join evaluation in temporal databases. Our purpose is twofold. We first survey all previously proposed temporal join operators. While many temporal join operators have been defined in previous work, this work has been done largely in isolation from competing proposals, with little...

  7. Dimensionality reduction with unsupervised nearest neighbors

    CERN Document Server

    Kramer, Oliver

    2013-01-01

    This book is devoted to a novel approach for dimensionality reduction based on the famous nearest neighbor method that is a powerful classification and regression approach. It starts with an introduction to machine learning concepts and a real-world application from the energy domain. Then, unsupervised nearest neighbors (UNN) is introduced as efficient iterative method for dimensionality reduction. Various UNN models are developed step by step, reaching from a simple iterative strategy for discrete latent spaces to a stochastic kernel-based algorithm for learning submanifolds with independent parameterizations. Extensions that allow the embedding of incomplete and noisy patterns are introduced. Various optimization approaches are compared, from evolutionary to swarm-based heuristics. Experimental comparisons to related methodologies taking into account artificial test data sets and also real-world data demonstrate the behavior of UNN in practical scenarios. The book contains numerous color figures to illustr...

  8. Microwave joining of SiC ceramics and composites

    Energy Technology Data Exchange (ETDEWEB)

    Ahmad, I.; Silberglitt, R.; Tian, Y.L. [FM Technologies, Inc., Fairfax, VA (United States); Katz, J.D. [Los Alamos National Lab., NM (United States)

    1997-04-01

    Potential applications of SiC include components for advanced turbine engines, tube assemblies for radiant burners and petrochemical processing and heat exchangers for high efficiency electric power generation systems. Reliable methods for joining SiC are required in order to cost-effectively fabricate components for these applications from commercially available shapes and sizes. This manuscript reports the results of microwave joining experiments performed using two different types of SiC materials. The first were on reaction bonded SiC, and produced joints with fracture toughness equal to or greater than that of the base material over an extended range of joining temperatures. The second were on continuous fiber-reinforced SiC/SiC composite materials, which were successfully joined with a commercial active brazing alloy, as well as by using a polymer precursor.

  9. Hyperplane distance neighbor clustering based on local discriminant analysis for complex chemical processes monitoring

    Energy Technology Data Exchange (ETDEWEB)

    Lu, Chunhong; Xiao, Shaoqing; Gu, Xiaofeng [Jiangnan University, Wuxi (China)

    2014-11-15

    The collected training data often include both normal and faulty samples for complex chemical processes. However, some monitoring methods, such as partial least squares (PLS), principal component analysis (PCA), independent component analysis (ICA) and Fisher discriminant analysis (FDA), require fault-free data to build the normal operation model. These techniques are applicable after the preliminary step of data clustering is applied. We here propose a novel hyperplane distance neighbor clustering (HDNC) based on the local discriminant analysis (LDA) for chemical process monitoring. First, faulty samples are separated from normal ones using the HDNC method. Then, the optimal subspace for fault detection and classification can be obtained using the LDA approach. The proposed method takes the multimodality within the faulty data into account, and thus improves the capability of process monitoring significantly. The HDNC-LDA monitoring approach is applied to two simulation processes and then compared with the conventional FDA based on the K-nearest neighbor (KNN-FDA) method. The results obtained in two different scenarios demonstrate the superiority of the HDNC-LDA approach in terms of fault detection and classification accuracy.

  10. Hyperplane distance neighbor clustering based on local discriminant analysis for complex chemical processes monitoring

    International Nuclear Information System (INIS)

    Lu, Chunhong; Xiao, Shaoqing; Gu, Xiaofeng

    2014-01-01

    The collected training data often include both normal and faulty samples for complex chemical processes. However, some monitoring methods, such as partial least squares (PLS), principal component analysis (PCA), independent component analysis (ICA) and Fisher discriminant analysis (FDA), require fault-free data to build the normal operation model. These techniques are applicable after the preliminary step of data clustering is applied. We here propose a novel hyperplane distance neighbor clustering (HDNC) based on the local discriminant analysis (LDA) for chemical process monitoring. First, faulty samples are separated from normal ones using the HDNC method. Then, the optimal subspace for fault detection and classification can be obtained using the LDA approach. The proposed method takes the multimodality within the faulty data into account, and thus improves the capability of process monitoring significantly. The HDNC-LDA monitoring approach is applied to two simulation processes and then compared with the conventional FDA based on the K-nearest neighbor (KNN-FDA) method. The results obtained in two different scenarios demonstrate the superiority of the HDNC-LDA approach in terms of fault detection and classification accuracy

  11. Including RNA secondary structures improves accuracy and robustness in reconstruction of phylogenetic trees.

    Science.gov (United States)

    Keller, Alexander; Förster, Frank; Müller, Tobias; Dandekar, Thomas; Schultz, Jörg; Wolf, Matthias

    2010-01-15

    In several studies, secondary structures of ribosomal genes have been used to improve the quality of phylogenetic reconstructions. An extensive evaluation of the benefits of secondary structure, however, is lacking. This is the first study to counter this deficiency. We inspected the accuracy and robustness of phylogenetics with individual secondary structures by simulation experiments for artificial tree topologies with up to 18 taxa and for divergency levels in the range of typical phylogenetic studies. We chose the internal transcribed spacer 2 of the ribosomal cistron as an exemplary marker region. Simulation integrated the coevolution process of sequences with secondary structures. Additionally, the phylogenetic power of marker size duplication was investigated and compared with sequence and sequence-structure reconstruction methods. The results clearly show that accuracy and robustness of Neighbor Joining trees are largely improved by structural information in contrast to sequence only data, whereas a doubled marker size only accounts for robustness. Individual secondary structures of ribosomal RNA sequences provide a valuable gain of information content that is useful for phylogenetics. Thus, the usage of ITS2 sequence together with secondary structure for taxonomic inferences is recommended. Other reconstruction methods as maximum likelihood, bayesian inference or maximum parsimony may equally profit from secondary structure inclusion. This article was reviewed by Shamil Sunyaev, Andrea Tanzer (nominated by Frank Eisenhaber) and Eugene V. Koonin. Reviewed by Shamil Sunyaev, Andrea Tanzer (nominated by Frank Eisenhaber) and Eugene V. Koonin. For the full reviews, please go to the Reviewers' comments section.

  12. Blind-date Conversation Joining

    Directory of Open Access Journals (Sweden)

    Luca Cesari

    2013-07-01

    Full Text Available We focus on a form of joining conversations among multiple parties in service-oriented applications where a client may asynchronously join an existing conversation without need to know in advance any information about it. More specifically, we show how the correlation mechanism provided by orchestration languages enables a form of conversation joining that is completely transparent to clients and that we call 'blind-date joining'. We provide an implementation of this strategy by using the standard orchestration language WS-BPEL. We then present its formal semantics by resorting to COWS, a process calculus specifically designed for modelling service-oriented applications. We illustrate our approach by means of a simple, but realistic, case study from the online games domain.

  13. Object-based methods for individual tree identification and tree species classification from high-spatial resolution imagery

    Science.gov (United States)

    Wang, Le

    2003-10-01

    Modern forest management poses an increasing need for detailed knowledge of forest information at different spatial scales. At the forest level, the information for tree species assemblage is desired whereas at or below the stand level, individual tree related information is preferred. Remote Sensing provides an effective tool to extract the above information at multiple spatial scales in the continuous time domain. To date, the increasing volume and readily availability of high-spatial-resolution data have lead to a much wider application of remotely sensed products. Nevertheless, to make effective use of the improving spatial resolution, conventional pixel-based classification methods are far from satisfactory. Correspondingly, developing object-based methods becomes a central challenge for researchers in the field of Remote Sensing. This thesis focuses on the development of methods for accurate individual tree identification and tree species classification. We develop a method in which individual tree crown boundaries and treetop locations are derived under a unified framework. We apply a two-stage approach with edge detection followed by marker-controlled watershed segmentation. Treetops are modeled from radiometry and geometry aspects. Specifically, treetops are assumed to be represented by local radiation maxima and to be located near the center of the tree-crown. As a result, a marker image was created from the derived treetop to guide a watershed segmentation to further differentiate overlapping trees and to produce a segmented image comprised of individual tree crowns. The image segmentation method developed achieves a promising result for a 256 x 256 CASI image. Then further effort is made to extend our methods to the multiscales which are constructed from a wavelet decomposition. A scale consistency and geometric consistency are designed to examine the gradients along the scale-space for the purpose of separating true crown boundary from unwanted

  14. Rule-based detection of intrathoracic airway trees

    International Nuclear Information System (INIS)

    Sonka, M.; Park, W.; Hoffman, E.A.

    1996-01-01

    New sensitive and reliable methods for assessing alterations in regional lung structure and function are critically important for the investigation and treatment of pulmonary diseases. Accurate identification of the airway tree will provide an assessment of airway structure and will provide a means by which multiple volumetric images of the lung at the same lung volume over time can be used to assess regional parenchymal changes. The authors describe a novel rule-based method for the segmentation of airway trees from three-dimensional (3-D) sets of computed tomography (CT) images, and its validation. The presented method takes advantage of a priori anatomical knowledge about pulmonary airway and vascular trees and their interrelationships. The method is based on a combination of 3-D seeded region growing that is used to identify large airways, rule-based two-dimensional (2-D) segmentation of individual CT slices to identify probable locations of smaller diameter airways, and merging of airway regions across the 3-D set of slices resulting in a tree-like airway structure. The method was validated in 40 3-mm-thick CT sections from five data sets of canine lungs scanned via electron beam CT in vivo with lung volume held at a constant pressure. The method's performance was compared with that of the conventional 3-D region growing method. The method substantially outperformed an existing conventional approach to airway tree detection

  15. Historical harvests reduce neighboring old-growth basal area across a forest landscape.

    Science.gov (United States)

    Bell, David M; Spies, Thomas A; Pabst, Robert

    2017-07-01

    While advances in remote sensing have made stand, landscape, and regional assessments of the direct impacts of disturbance on forests quite common, the edge influence of timber harvesting on the structure of neighboring unharvested forests has not been examined extensively. In this study, we examine the impact of historical timber harvests on basal area patterns of neighboring old-growth forests to assess the magnitude and scale of harvest edge influence in a forest landscape of western Oregon, USA. We used lidar data and forest plot measurements to construct 30-m resolution live tree basal area maps in lower and middle elevation mature and old-growth forests. We assessed how edge influence on total, upper canopy, and lower canopy basal area varied across this forest landscape as a function of harvest characteristics (i.e., harvest size and age) and topographic conditions in the unharvested area. Upper canopy, lower canopy, and total basal area increased with distance from harvest edge and elevation. Forests within 75 m of harvest edges (20% of unharvested forests) had 4% to 6% less live tree basal area compared with forest interiors. An interaction between distance from harvest edge and elevation indicated that elevation altered edge influence in this landscape. We observed a positive edge influence at low elevations (800 m). Surprisingly, we found no or weak effects of harvest age (13-60 yr) and harvest area (0.2-110 ha) on surrounding unharvested forest basal area, implying that edge influence was relatively insensitive to the scale of disturbance and multi-decadal recovery processes. Our study indicates that the edge influence of past clearcutting on the structure of neighboring uncut old-growth forests is widespread and persistent. These indirect and diffuse legacies of historical timber harvests complicate forest management decision-making in old-growth forest landscapes by broadening the traditional view of stand boundaries. Furthermore, the consequences

  16. Molecular Characterization and Differential Expression of an Olfactory Receptor Gene Family in the White-Backed Planthopper Sogatella furcifera Based on Transcriptome Analysis.

    Directory of Open Access Journals (Sweden)

    Ming He

    Full Text Available The white-backed planthopper, Sogatella furcifera, a notorious rice pest in Asia, employs host plant volatiles as cues for host location. In insects, odor detection is mediated by two types of olfactory receptors: odorant receptors (ORs and ionotropic receptors (IRs. In this study, we identified 63 SfurORs and 14 SfurIRs in S. furcifera based on sequences obtained from the head transcriptome and bioinformatics analysis. The motif-pattern of 130 hemiptera ORs indicated an apparent differentiation in this order. Phylogenetic trees of the ORs and IRs were constructed using neighbor-joining estimates. Most of the ORs had orthologous genes, but a specific OR clade was identified in S. furcifera, which suggests that these ORs may have specific olfactory functions in this species. Our results provide a basis for further investigations of how S. furcifera coordinates its olfactory receptor genes with its plant hosts, thereby providing a foundation for novel pest management approaches based on these genes.

  17. [Identification of common medicinal snakes in medicated liquor of Guangdong by COI barcode sequence].

    Science.gov (United States)

    Liao, Jing; Chao, Zhi; Zhang, Liang

    2013-11-01

    To identify the common snakes in medicated liquor of Guangdong using COI barcode sequence,and to test the feasibility. The COI barcode sequences of collected medicinal snakes were amplified and sequenced. The sequences combined with the data from GenBank were analyzed for divergence and building a neighbor-joining(NJ) tree with MEGA 5.0. The genetic distance and NJ tree demonstrated that there were 241 variable sites in these species, and the average (A + T) content of 56.2% was higher than the average (G + C) content of 43.7%. The maximum interspecific genetic distance was 0.2568, and the minimum was 0. 1519. In the NJ tree,each species formed a monophyletic clade with bootstrap supports of 100%. DNA barcoding identification method based on the COI sequence is accurate and can be applied to identify the common medicinal snakes.

  18. A lightweight neighbor-info-based routing protocol for no-base-station taxi-call system.

    Science.gov (United States)

    Zhu, Xudong; Wang, Jinhang; Chen, Yunchao

    2014-01-01

    Since the quick topology change and short connection duration, the VANET has had unstable routing and wireless signal quality. This paper proposes a kind of lightweight routing protocol-LNIB for call system without base station, which is applicable to the urban taxis. LNIB maintains and predicts neighbor information dynamically, thus finding the reliable path between the source and the target. This paper describes the protocol in detail and evaluates the performance of this protocol by simulating under different nodes density and speed. The result of evaluation shows that the performance of LNIB is better than AODV which is a classic protocol in taxi-call scene.

  19. EEG feature selection method based on decision tree.

    Science.gov (United States)

    Duan, Lijuan; Ge, Hui; Ma, Wei; Miao, Jun

    2015-01-01

    This paper aims to solve automated feature selection problem in brain computer interface (BCI). In order to automate feature selection process, we proposed a novel EEG feature selection method based on decision tree (DT). During the electroencephalogram (EEG) signal processing, a feature extraction method based on principle component analysis (PCA) was used, and the selection process based on decision tree was performed by searching the feature space and automatically selecting optimal features. Considering that EEG signals are a series of non-linear signals, a generalized linear classifier named support vector machine (SVM) was chosen. In order to test the validity of the proposed method, we applied the EEG feature selection method based on decision tree to BCI Competition II datasets Ia, and the experiment showed encouraging results.

  20. Tree spacing impacts the individual incidence of Moniliophthora roreri disease in cacao agroforests.

    Science.gov (United States)

    Ngo Bieng, Marie Ange; Alem, Laudine; Curtet, Chloé; Tixier, Philippe

    2017-11-01

    Using conventional pesticides in crop protection has raised serious environmental concerns and there is therefore a need for integrated pest management (IPM) methods. In this paper, we found that the spacing of trees can impact disease, which could result in a reduction in pesticide applications and may act as a potential IPM method. We studied Frosty Pod Rot (FPR) in 20 cacao agroforests in Costa Rica (Upala region). Using a generalized linear mixed model, we analyzed the impact of the neighborhood composition and distance from a studied cacao individual on its individual FPR incidence. We found that the number of cacao tree neighbors in a radius of 3.7 m and the number of fruit trees in a radius of 4.3 m had a significant negative influence on the incidence of FPR on individual cacao trees. Moreover, cacao tree neighbors had the most significant local influence compared to the neighborhood of other taller categories such as fruit or forest trees. The mechanisms involved are related to the barrier effect, due to the effectiveness of the cacao tree's architecture as an efficient barrier against FPR spore dispersal. This paper provides new insights into optimization of the spatial environment around each host as an original IPM method. © 2017 Society of Chemical Industry. © 2017 Society of Chemical Industry.

  1. Environmentally friendly joining of tubes by their ends

    DEFF Research Database (Denmark)

    Silva, Carlos M.A.; Nielsen, Chris Valentin; Alves, Luis M.

    2015-01-01

    This paper proposes an environmentally friendly joining process for connecting tubes by their ends that has the potential to replace current solutions based on fastened, crimped, welded, brazed or adhesive bonded joints. The process is based on a new type of tubular lap joint produced by local...... of deformation and the process feasibility window, and destructive testing to establish the working limits of tubular lap joints under different type of loading conditions. Results demonstrate that the proposed joining process is a flexible and cost-effective technology for connecting tubes by their ends...

  2. The ghosts of trees past: savanna trees create enduring legacies in plant species composition.

    Science.gov (United States)

    Stahlheber, Karen A; Crispin, Kimberly L; Anton, Cassidy; D'Antonio, Carla M

    2015-09-01

    Isolated trees in savannas worldwide are known to modify their local environment and interact directly with neighboring plants. Less is known about how related tree species differ in their impacts on surrounding communities, how the effects of trees vary between years, and how composition might change following loss of the tree. To address these knowledge gaps, we explored the following questions: How do savanna trees influence the surrounding composition of herbaceous plants? Is the influence of trees consistent across different species and years? How does this change following the death of the tree? We surveyed herbaceous species composition and environmental attributes surrounding living and dead evergreen and deciduous Quercus trees in California (USA) savannas across several years that differed in their total precipitation. Oak trees of all species created distinct, homogenous understory communities dominated by exotic grasses across several sites. The composition of the low-diversity understory communities showed less interannual variation than open grassland, despite a two-fold difference in precipitation between the driest and wettest year. Vegetation composition was correlated with variation in soil properties, which were strongly affected by trees. Oaks also influenced the communities beyond the edge of the crown, but this depended on site and oak species. Low-diversity understory communities persisted up to 43 years following the death of the tree. A gradual decline in the effect of trees on the physical, environment following death did not result in vegetation becoming more similar to open grassland over time. The presence of long-lasting legacies of past tree crowns highlights the difficulty of assigning control of the current distribution of herbaceous species in grassland to their contemporary environment.

  3. A Novel Quantum Solution to Privacy-Preserving Nearest Neighbor Query in Location-Based Services

    Science.gov (United States)

    Luo, Zhen-yu; Shi, Run-hua; Xu, Min; Zhang, Shun

    2018-04-01

    We present a cheating-sensitive quantum protocol for Privacy-Preserving Nearest Neighbor Query based on Oblivious Quantum Key Distribution and Quantum Encryption. Compared with the classical related protocols, our proposed protocol has higher security, because the security of our protocol is based on basic physical principles of quantum mechanics, instead of difficulty assumptions. Especially, our protocol takes single photons as quantum resources and only needs to perform single-photon projective measurement. Therefore, it is feasible to implement this protocol with the present technologies.

  4. Insights into Korean red fox (Vulpes vulpes) based on mitochondrial cytochrome b sequence variation in East Asia.

    Science.gov (United States)

    Yu, Jeong-Nam; Han, Sang-Hoon; Kim, Bang-Hwan; Kryukov, Alexey P; Kim, Soonok; Lee, Byoung-Yoon; Kwak, Myounghai

    2012-11-01

    The red fox (Vulpes vulpes) is the most widely distributed terrestrial carnivore in the world, occurring throughout most of North America, Europe, Asia, and North Africa. In South Korea, however, this species has been drastically reduced due to habitat loss and poaching. Consequently, it is classified as an endangered species in Korea. As a first step of a planned red fox restoration project, preserved red fox museum specimens were used to determine the genetic status of red foxes that had previously inhabited South Korea against red foxes from neighboring countries. Total eighty three mtDNA cytochrome b sequences, including 22 newly obtained East Asian red fox sequences and worldwide red fox sequences from NCBI, were clustered into three clades (i.e., I, II, and III) based on haplotype network and neighbor-joining trees. The mean genetic distance between clades was 2.0%. Clade III contained South Korean and other East Asian samples in addition to Eurasian and North Pacific individuals. In clade III, South Korean individuals were separated into two lineages of Eurasian and North Pacific groups, showing unclear phylogeographic structuring and admixture. This suggests that South Korean red fox populations may have been composed of individuals from these two different genetic lineages.

  5. Joining uranium to steel

    International Nuclear Information System (INIS)

    Perkins, M.A.

    1976-05-01

    A method has been devised which will allow the joining of uranium to steel by fusion welding through the use of an intermediate material. Uranium-0.5 titanium was joined to AISI 304L stainless steel by using a vanadium insert. Also, a method is now available for selecting possible filler metals when two entirely dissimilar metals need to be joined. This method allows a quantitative ranking to be made of the possible filler metals and thus the most likely candidate can be selected

  6. The clinic as a good corporate neighbor.

    Science.gov (United States)

    Sass, Hans-Martin

    2013-02-01

    Clinics today specialize in health repair services similar to car repair shops; procedures and prices are standardized, regulated, and inflexibly uniform. Clinics of the future have to become Health Care Centers in order to be more respected and more effective corporate neighbors in offering outreach services in health education and preventive health care. The traditional concept of care for health is much broader than repair management and includes the promotion of lay health competence and responsibility in healthy social and natural environments. The corporate profile and ethics of the clinic as a good and competitive local neighbor will have to focus on [a] better personalized care, [b] education and services in preventive care, [c] direct or web-based information and advice for general, seasonal, or age related health risks, and on developing and improving trustworthy character traits of the clinic as a corporate person and a good neighbor.

  7. Thin layer joining by gas adsorption

    Energy Technology Data Exchange (ETDEWEB)

    Taga, Yasunori, E-mail: y-taga@isc.chubu.ac.jp; Fukumura, Toshio

    2014-10-01

    Highlights: • We report thin layer molecular joining between glass and COP by gas adsorption. Thickness of joining layer is 1–2 nm and joining process was carried out at low temperature at about 100 °C. • Adhesion strength measured by 180 degree peel test revealed to be 1–10 N/25 mm and the joined stack showed high durability for practical use. - Abstract: Attempt has been made to join borosilicate glass and cycloolefin (COP) polymer film by using gas adsorption method. After corona plasma treat, COP was exposed to (3-glycidoxypropyl) trimethoxysilane (GPS) and glass to (3-aminopropyl) triethoxysilane (APS) both in air atmosphere, resulting in co-adsorption of water vapor in the atmosphere and organosilane gases. Surface characterization of plasma treated and gas adsorbed surfaces was carried out by X-ray photoelectron spectroscopy (XPS) using Mg Kα X-ray source. Joining was carried out by a roll laminator after contact of both surfaces at room temperature, followed by annealing at 130 °C for 10 min. Adhesion strength was evaluated by 180 degree peel test based on ASTM D-903 and durability was examined under the conditions of 60 °C and 95% RH. It was found that after plasma treatment, complex functional groups such as C-H, C-O, C=O, O-C=O and CO{sub 3} were found on COP and O-H on glass. Thickness of GPS gas adsorption layer on COP was evaluated by the XPS to be at least 1.1 nm by taking inelastic mean free path of Si{sub 2p} photoelectron into consideration. Joining force was found to be more than 5 N/25 mm corresponding to almost equal to COP bulk tensile strength. In addition, durability of this adhesion strength remained unchanged over 2000 h even after exposure to the durability test conditions of 60 °C and 95% RH. The results can be explained in terms of formation of H-H hydrogen bonding and Si-O covalent bonding via silanols will be made at the interface as a result of lamination and annealing processes. In conclusion, ultrathin joining method

  8. Local randomization in neighbor selection improves PRM roadmap quality

    KAUST Repository

    McMahon, Troy; Jacobs, Sam; Boyd, Bryan; Tapia, Lydia; Amato, Nancy M.

    2012-01-01

    Probabilistic Roadmap Methods (PRMs) are one of the most used classes of motion planning methods. These sampling-based methods generate robot configurations (nodes) and then connect them to form a graph (roadmap) containing representative feasible pathways. A key step in PRM roadmap construction involves identifying a set of candidate neighbors for each node. Traditionally, these candidates are chosen to be the k-closest nodes based on a given distance metric. In this paper, we propose a new neighbor selection policy called LocalRand(k,K'), that first computes the K' closest nodes to a specified node and then selects k of those nodes at random. Intuitively, LocalRand attempts to benefit from random sampling while maintaining the higher levels of local planner success inherent to selecting more local neighbors. We provide a methodology for selecting the parameters k and K'. We perform an experimental comparison which shows that for both rigid and articulated robots, LocalRand results in roadmaps that are better connected than the traditional k-closest policy or a purely random neighbor selection policy. The cost required to achieve these results is shown to be comparable to k-closest. © 2012 IEEE.

  9. Local randomization in neighbor selection improves PRM roadmap quality

    KAUST Repository

    McMahon, Troy

    2012-10-01

    Probabilistic Roadmap Methods (PRMs) are one of the most used classes of motion planning methods. These sampling-based methods generate robot configurations (nodes) and then connect them to form a graph (roadmap) containing representative feasible pathways. A key step in PRM roadmap construction involves identifying a set of candidate neighbors for each node. Traditionally, these candidates are chosen to be the k-closest nodes based on a given distance metric. In this paper, we propose a new neighbor selection policy called LocalRand(k,K\\'), that first computes the K\\' closest nodes to a specified node and then selects k of those nodes at random. Intuitively, LocalRand attempts to benefit from random sampling while maintaining the higher levels of local planner success inherent to selecting more local neighbors. We provide a methodology for selecting the parameters k and K\\'. We perform an experimental comparison which shows that for both rigid and articulated robots, LocalRand results in roadmaps that are better connected than the traditional k-closest policy or a purely random neighbor selection policy. The cost required to achieve these results is shown to be comparable to k-closest. © 2012 IEEE.

  10. Unique competitive effects of lianas and trees in a tropical forest understory.

    Science.gov (United States)

    Wright, Alexandra; Tobin, Mike; Mangan, Scott; Schnitzer, Stefan A

    2015-02-01

    Lianas are an important component of tropical forests, contributing up to 25% of the woody stems and 35% of woody species diversity. Lianas invest less in structural support but more in leaves compared to trees of similar biomass. These physiological and morphological differences suggest that lianas may interact with neighboring plants in ways that are different from similarly sized trees. However, the vast majority of past liana competition studies have failed to identify the unique competitive effects of lianas by controlling for the amount of biomass removed. We assessed liana competition in the forest understory over the course of 3 years by removing liana biomass and an equal amount of tree biomass in 40 plots at 10 sites in a secondary tropical moist forest in central Panama. We found that growth of understory trees and lianas, as well as planted seedlings, was limited due to competitive effects from both lianas and trees, though the competitive impacts varied by species, season, and size of neighbors. The removal of trees resulted in greater survival of planted seedlings compared to the removal of lianas, apparently related to a greater release from competition for light. In contrast, lianas had a species-specific negative effect on drought-tolerant Dipteryx oleifera seedlings during the dry season, potentially due to competition for water. We conclude that, at local scales, lianas and trees have unique and differential effects on understory dynamics, with lianas potentially competing more strongly during the dry season, and trees competing more strongly for light.

  11. Use of a cobalt-based metallic glass for joining MoSi{sub 2} to stainless steel

    Energy Technology Data Exchange (ETDEWEB)

    Vaidya, R.U.; Rangaswamy, P.; Misra, A.; Gallegos, D.E.; Castro, R.G.; Petrovic, J.J. [Los Alamos National Lab., NM (United States). Materials Science and Technology Div.; Butt, D.P. [Florida Univ., Gainesville, FL (United States). Dept. of Materials Science and Engineering

    2002-07-01

    The successful use of a cobalt-based metallic glass in joining molybdenum disilicide (MoSi{sub 2}) to stainless steel 316L was demonstrated. Such joints are being investigated for sensor tube applications in glass melting operations. The cobalt-based metallic-glass (METGLAS{sup TM} 2714A) was found to wet the MoSi{sub 2} and stainless steel surfaces and provide high quality joints. Joining was completed at 1050 C for 60 minutes in two different ways; either by feeding excess braze into the braze gap upon heating or by constraining the MoSi{sub 2}/stainless steel assembly with an alumina (Al{sub 2}O{sub 3}) fixture during the heating cycle. These steps were necessary to ensure the production of a high quality void free joint. Post-brazing metallographic evaluations coupled with quantitative elemental analysis indicated the presence of a Co-Cr-Si ternary phase with CoSi and CoSi{sub 2} precipitates within the braze. The residual stresses in these molybdenum disilicide (MoSi{sub 2})/stainless steel 316 L joints were evaluated using X-ray diffraction and instrumented indentation techniques. These measurements revealed that significant differences are induced in the residual stresses in MoSi{sub 2} and stainless steel depending on the joining technique employed. Push-out tests were carried out on these joints to evaluate the joint strength. (orig.)

  12. Aftershock identification problem via the nearest-neighbor analysis for marked point processes

    Science.gov (United States)

    Gabrielov, A.; Zaliapin, I.; Wong, H.; Keilis-Borok, V.

    2007-12-01

    The centennial observations on the world seismicity have revealed a wide variety of clustering phenomena that unfold in the space-time-energy domain and provide most reliable information about the earthquake dynamics. However, there is neither a unifying theory nor a convenient statistical apparatus that would naturally account for the different types of seismic clustering. In this talk we present a theoretical framework for nearest-neighbor analysis of marked processes and obtain new results on hierarchical approach to studying seismic clustering introduced by Baiesi and Paczuski (2004). Recall that under this approach one defines an asymmetric distance D in space-time-energy domain such that the nearest-neighbor spanning graph with respect to D becomes a time- oriented tree. We demonstrate how this approach can be used to detect earthquake clustering. We apply our analysis to the observed seismicity of California and synthetic catalogs from ETAS model and show that the earthquake clustering part is statistically different from the homogeneous part. This finding may serve as a basis for an objective aftershock identification procedure.

  13. [Discussion on the botanical origin of Isatidis radix and Isatidis folium based on DNA barcoding].

    Science.gov (United States)

    Sun, Zhi-Ying; Pang, Xiao-Hui

    2013-12-01

    This paper aimed to investigate the botanical origins of Isatidis Radix and Isatidis Folium, and clarify the confusion of its classification. The second internal transcribed spacer (ITS2) of ribosomal DNA, the chloroplast matK gene of 22 samples from some major production areas were amplified and sequenced. Sequence assembly and consensus sequence generation were performed using the CodonCode Aligner. Phylogenetic study was performed using MEGA 4.0 software in accordance with the Kimura 2-Parameter (K2P) model, and the phylogenetic tree was constructed using the neighbor-joining methods. The results showed that the length of ITS2 sequence of the botanical origins of Isatidis Radix and Isatidis Folium was 191 bp. The sequence showed that some samples had several SNP sites, and some samples had heterozygosis sites. In the NJ tree, based on ITS2 sequence, the studied samples were separated into two groups, and one of them was gathered with Isatis tinctoria L. The studied samples also were divided into two groups obviously based on the chloroplast matK gene. In conclusion, our results support that the botanical origins of Isatidis Radix and Isatidis Folium are Isatis indigotica Fortune, and Isatis indigotica and Isatis tinctoria are two distinct species. This study doesn't support the opinion about the combination of these two species in Flora of China.

  14. Anchoring quartet-based phylogenetic distances and applications to species tree reconstruction.

    Science.gov (United States)

    Sayyari, Erfan; Mirarab, Siavash

    2016-11-11

    Inferring species trees from gene trees using the coalescent-based summary methods has been the subject of much attention, yet new scalable and accurate methods are needed. We introduce DISTIQUE, a new statistically consistent summary method for inferring species trees from gene trees under the coalescent model. We generalize our results to arbitrary phylogenetic inference problems; we show that two arbitrarily chosen leaves, called anchors, can be used to estimate relative distances between all other pairs of leaves by inferring relevant quartet trees. This results in a family of distance-based tree inference methods, with running times ranging between quadratic to quartic in the number of leaves. We show in simulated studies that DISTIQUE has comparable accuracy to leading coalescent-based summary methods and reduced running times.

  15. The hydrological vulnerability of western North American boreal tree species based on ground-based observations of tree mortality

    Science.gov (United States)

    Hember, R. A.; Kurz, W. A.; Coops, N. C.

    2017-12-01

    Several studies indicate that climate change has increased rates of tree mortality, adversely affecting timber supply and carbon storage in western North American boreal forests. Statistical models of tree mortality can play a complimentary role in detecting and diagnosing forest change. Yet, such models struggle to address real-world complexity, including expectations that hydrological vulnerability arises from both drought stress and excess-water stress, and that these effects vary by species, tree size, and competitive status. Here, we describe models that predict annual probability of tree mortality (Pm) of common boreal tree species based on tree height (H), biomass of larger trees (BLT), soil water content (W), reference evapotranspiration (E), and two-way interactions. We show that interactions among H and hydrological variables are consistently significant. Vulnerability to extreme droughts consistently increases as H approaches maximum observed values of each species, while some species additionally show increasing vulnerability at low H. Some species additionally show increasing vulnerability to low W under high BLT, or increasing drought vulnerability under low BLT. These results suggest that vulnerability of trees to increasingly severe droughts depends on the hydraulic efficiency, competitive status, and microclimate of individual trees. Static simulations of Pm across a 1-km grid (i.e., with time-independent inputs of H, BLT, and species composition) indicate complex spatial patterns in the time trends during 1965-2014 and a mean change in Pm of 42 %. Lastly, we discuss how the size-dependence of hydrological vulnerability, in concert with increasingly severe drought events, may shape future responses of stand-level biomass production to continued warming and increasing carbon dioxide concentration in the region.

  16. Population genetic structure and phylogeographical pattern of a relict tree fern, Alsophila spinulosa (Cyatheaceae), inferred from cpDNA atpB- rbcL intergenic spacers.

    Science.gov (United States)

    Su, Yingjuan; Wang, Ting; Zheng, Bo; Jiang, Yu; Chen, Guopei; Gu, Hongya

    2004-11-01

    Sequences of chloroplast DNA (cpDNA) atpB- rbcL intergenic spacers of individuals of a tree fern species, Alsophila spinulosa, collected from ten relict populations distributed in the Hainan and Guangdong provinces, and the Guangxi Zhuang region in southern China, were determined. Sequence length varied from 724 bp to 731 bp, showing length polymorphism, and base composition was with high A+T content between 63.17% and 63.95%. Sequences were neutral in terms of evolution (Tajima's criterion D=-1.01899, P>0.10 and Fu and Li's test D*=-1.39008, P>0.10; F*=-1.49775, P>0.10). A total of 19 haplotypes were identified based on nucleotide variation. High levels of haplotype diversity (h=0.744) and nucleotide diversity (Dij=0.01130) were detected in A. spinulosa, probably associated with its long evolutionary history, which has allowed the accumulation of genetic variation within lineages. Both the minimum spanning network and neighbor-joining trees generated for haplotypes demonstrated that current populations of A. spinulosa existing in Hainan, Guangdong, and Guangxi were subdivided into two geographical groups. An analysis of molecular variance indicated that most of the genetic variation (93.49%, P<0.001) was partitioned among regions. Wright's isolation by distance model was not supported across extant populations. Reduced gene flow by the Qiongzhou Strait and inbreeding may result in the geographical subdivision between the Hainan and Guangdong + Guangxi populations (FST=0.95, Nm=0.03). Within each region, the star-like pattern of phylogeography of haplotypes implied a population expansion process during evolutionary history. Gene genealogies together with coalescent theory provided significant information for uncovering phylogeography of A. spinulosa.

  17. K-Nearest Neighbor Intervals Based AP Clustering Algorithm for Large Incomplete Data

    Directory of Open Access Journals (Sweden)

    Cheng Lu

    2015-01-01

    Full Text Available The Affinity Propagation (AP algorithm is an effective algorithm for clustering analysis, but it can not be directly applicable to the case of incomplete data. In view of the prevalence of missing data and the uncertainty of missing attributes, we put forward a modified AP clustering algorithm based on K-nearest neighbor intervals (KNNI for incomplete data. Based on an Improved Partial Data Strategy, the proposed algorithm estimates the KNNI representation of missing attributes by using the attribute distribution information of the available data. The similarity function can be changed by dealing with the interval data. Then the improved AP algorithm can be applicable to the case of incomplete data. Experiments on several UCI datasets show that the proposed algorithm achieves impressive clustering results.

  18. Including RNA secondary structures improves accuracy and robustness in reconstruction of phylogenetic trees

    Directory of Open Access Journals (Sweden)

    Dandekar Thomas

    2010-01-01

    Full Text Available Abstract Background In several studies, secondary structures of ribosomal genes have been used to improve the quality of phylogenetic reconstructions. An extensive evaluation of the benefits of secondary structure, however, is lacking. Results This is the first study to counter this deficiency. We inspected the accuracy and robustness of phylogenetics with individual secondary structures by simulation experiments for artificial tree topologies with up to 18 taxa and for divergency levels in the range of typical phylogenetic studies. We chose the internal transcribed spacer 2 of the ribosomal cistron as an exemplary marker region. Simulation integrated the coevolution process of sequences with secondary structures. Additionally, the phylogenetic power of marker size duplication was investigated and compared with sequence and sequence-structure reconstruction methods. The results clearly show that accuracy and robustness of Neighbor Joining trees are largely improved by structural information in contrast to sequence only data, whereas a doubled marker size only accounts for robustness. Conclusions Individual secondary structures of ribosomal RNA sequences provide a valuable gain of information content that is useful for phylogenetics. Thus, the usage of ITS2 sequence together with secondary structure for taxonomic inferences is recommended. Other reconstruction methods as maximum likelihood, bayesian inference or maximum parsimony may equally profit from secondary structure inclusion. Reviewers This article was reviewed by Shamil Sunyaev, Andrea Tanzer (nominated by Frank Eisenhaber and Eugene V. Koonin. Open peer review Reviewed by Shamil Sunyaev, Andrea Tanzer (nominated by Frank Eisenhaber and Eugene V. Koonin. For the full reviews, please go to the Reviewers' comments section.

  19. Enhanced Approximate Nearest Neighbor via Local Area Focused Search.

    Energy Technology Data Exchange (ETDEWEB)

    Gonzales, Antonio [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Blazier, Nicholas Paul [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States)

    2017-02-01

    Approximate Nearest Neighbor (ANN) algorithms are increasingly important in machine learning, data mining, and image processing applications. There is a large family of space- partitioning ANN algorithms, such as randomized KD-Trees, that work well in practice but are limited by an exponential increase in similarity comparisons required to optimize recall. Additionally, they only support a small set of similarity metrics. We present Local Area Fo- cused Search (LAFS), a method that enhances the way queries are performed using an existing ANN index. Instead of a single query, LAFS performs a number of smaller (fewer similarity comparisons) queries and focuses on a local neighborhood which is refined as candidates are identified. We show that our technique improves performance on several well known datasets and is easily extended to general similarity metrics using kernel projection techniques.

  20. Nonbinary Tree-Based Phylogenetic Networks

    NARCIS (Netherlands)

    Jetten, L.; van Iersel, L.J.J.

    2018-01-01

    Rooted phylogenetic networks are used to describe evolutionary histories that contain non-treelike evolutionary events such as hybridization and horizontal gene transfer. In some cases, such histories can be described by a phylogenetic base-tree with additional linking arcs, which can for example

  1. A knowledge-based approach to the evaluation of fault trees

    International Nuclear Information System (INIS)

    Hwang, Yann-Jong; Chow, Louis R.; Huang, Henry C.

    1996-01-01

    A list of critical components is useful for determining the potential problems of a complex system. However, to find this list through evaluating the fault trees is expensive and time consuming. This paper intends to propose an integrated software program which consists of a fault tree constructor, a knowledge base, and an efficient algorithm for evaluating minimal cut sets of a large fault tree. The proposed algorithm uses the approaches of top-down heuristic searching and the probability-based truncation. That makes the evaluation of fault trees obviously efficient and provides critical components for solving the potential problems in complex systems. Finally, some practical fault trees are included to illustrate the results

  2. Fuzzy probability based fault tree analysis to propagate and quantify epistemic uncertainty

    International Nuclear Information System (INIS)

    Purba, Julwan Hendry; Sony Tjahyani, D.T.; Ekariansyah, Andi Sofrany; Tjahjono, Hendro

    2015-01-01

    Highlights: • Fuzzy probability based fault tree analysis is to evaluate epistemic uncertainty in fuzzy fault tree analysis. • Fuzzy probabilities represent likelihood occurrences of all events in a fault tree. • A fuzzy multiplication rule quantifies epistemic uncertainty of minimal cut sets. • A fuzzy complement rule estimate epistemic uncertainty of the top event. • The proposed FPFTA has successfully evaluated the U.S. Combustion Engineering RPS. - Abstract: A number of fuzzy fault tree analysis approaches, which integrate fuzzy concepts into the quantitative phase of conventional fault tree analysis, have been proposed to study reliabilities of engineering systems. Those new approaches apply expert judgments to overcome the limitation of the conventional fault tree analysis when basic events do not have probability distributions. Since expert judgments might come with epistemic uncertainty, it is important to quantify the overall uncertainties of the fuzzy fault tree analysis. Monte Carlo simulation is commonly used to quantify the overall uncertainties of conventional fault tree analysis. However, since Monte Carlo simulation is based on probability distribution, this technique is not appropriate for fuzzy fault tree analysis, which is based on fuzzy probabilities. The objective of this study is to develop a fuzzy probability based fault tree analysis to overcome the limitation of fuzzy fault tree analysis. To demonstrate the applicability of the proposed approach, a case study is performed and its results are then compared to the results analyzed by a conventional fault tree analysis. The results confirm that the proposed fuzzy probability based fault tree analysis is feasible to propagate and quantify epistemic uncertainties in fault tree analysis

  3.  Optimizing relational algebra operations using discrimination-based joins and lazy products

    DEFF Research Database (Denmark)

    Henglein, Fritz

    We show how to implement in-memory execution of the core re- lational algebra operations of projection, selection and cross-product eciently, using discrimination-based joins and lazy products. We introduce the notion of (partitioning) discriminator, which par- titions a list of values according...... to a specied equivalence relation on keys the values are associated with. We show how discriminators can be dened generically, purely functionally, and eciently (worst-case linear time) on top of the array-based basic multiset discrimination algorithm of Cai and Paige (1995). Discriminators provide the basis...... the selection operation to recognize on the y whenever it is applied to a cross-product, in which case it can choose an ecient discrimination-based equijoin implementation. The techniques subsume most of the optimization techniques based on relational algebra equalities, without need for a query preprocessing...

  4. Tree-shrub associations in grazed woodlands: First rodents, then cattle?

    NARCIS (Netherlands)

    Smit, C.; Verwijmeren, M.

    2011-01-01

    Spatial associations of tree saplings with spiny or toxic plants in grazed woodlands are generally explained by associational resistance, i. e., protection against grazing via a well-defended neighbor. In this study, we tested whether directed seed dispersal and post-dispersal seed removal by wood

  5. Nearest unlike neighbor (NUN): an aid to decision confidence estimation

    Science.gov (United States)

    Dasarathy, Belur V.

    1995-09-01

    The concept of nearest unlike neighbor (NUN), proposed and explored previously in the design of nearest neighbor (NN) based decision systems, is further exploited in this study to develop a measure of confidence in the decisions made by NN-based decision systems. This measure of confidence, on the basis of comparison with a user-defined threshold, may be used to determine the acceptability of the decision provided by the NN-based decision system. The concepts, associated methodology, and some illustrative numerical examples using the now classical Iris data to bring out the ease of implementation and effectiveness of the proposed innovations are presented.

  6. Evaluation of the feasibility of joining titanium alloy to heavymet tungsten alloy

    Energy Technology Data Exchange (ETDEWEB)

    1978-06-07

    Information is presented on a program to select and evaluate methods of brazing and/or explosively welding Ti-6Al-4V titanium alloy to Heavymet, a tungsten-base metal containing up to about 20% alloying elements (nickel, copper, etc.) to improve its ductility and other mechanical properties. Designs permitting the reliable production of joints between these base metals were of interest too. While this investigation was primarily concerned with an engineering study of the problems associated with joining these base metals in the required configuration, limited experimental studies were conducted also. The joining methods are reviewed individually. Recommendations for developing a viable titanium-tungsten joining procedure are discussed.

  7. Evaluation of the feasibility of joining titanium alloy to heavymet tungsten alloy

    International Nuclear Information System (INIS)

    1978-01-01

    Information is presented on a program to select and evaluate methods of brazing and/or explosively welding Ti-6Al-4V titanium alloy to Heavymet, a tungsten-base metal containing up to about 20% alloying elements (nickel, copper, etc.) to improve its ductility and other mechanical properties. Designs permitting the reliable production of joints between these base metals were of interest too. While this investigation was primarily concerned with an engineering study of the problems associated with joining these base metals in the required configuration, limited experimental studies were conducted also. The joining methods are reviewed individually. Recommendations for developing a viable titanium-tungsten joining procedure are discussed

  8. Tree-based indexing for real-time ConvNet landmark-based visual place recognition

    Directory of Open Access Journals (Sweden)

    Yi Hou

    2017-01-01

    Full Text Available Recent impressive studies on using ConvNet landmarks for visual place recognition take an approach that involves three steps: (a detection of landmarks, (b description of the landmarks by ConvNet features using a convolutional neural network, and (c matching of the landmarks in the current view with those in the database views. Such an approach has been shown to achieve the state-of-the-art accuracy even under significant viewpoint and environmental changes. However, the computational burden in step (c significantly prevents this approach from being applied in practice, due to the complexity of linear search in high-dimensional space of the ConvNet features. In this article, we propose two simple and efficient search methods to tackle this issue. Both methods are built upon tree-based indexing. Given a set of ConvNet features of a query image, the first method directly searches the features’ approximate nearest neighbors in a tree structure that is constructed from ConvNet features of database images. The database images are voted on by features in the query image, according to a lookup table which maps each ConvNet feature to its corresponding database image. The database image with the highest vote is considered the solution. Our second method uses a coarse-to-fine procedure: the coarse step uses the first method to coarsely find the top-N database images, and the fine step performs a linear search in Hamming space of the hash codes of the ConvNet features to determine the best match. Experimental results demonstrate that our methods achieve real-time search performance on five data sets with different sizes and various conditions. Most notably, by achieving an average search time of 0.035 seconds/query, our second method improves the matching efficiency by the three orders of magnitude over a linear search baseline on a database with 20,688 images, with negligible loss in place recognition accuracy.

  9. Common Influence Join

    DEFF Research Database (Denmark)

    Yiu, Man Lung; Mamoulis, Nikos; Karras, Panagiotis

    2008-01-01

    We identify and formalize a novel join operator for two spatial pointsets P and Q. The common influence join (CIJ) returns the pairs of points (p,q),p isin P,q isin Q, such that there exists a location in space, being closer to p than to any other point in P and at the same time closer to q than ......-demand, is very efficient in practice, incurring only slightly higher I/O cost than the theoretical lower bound cost for the problem....

  10. Utilising Tree-Based Ensemble Learning for Speaker Segmentation

    DEFF Research Database (Denmark)

    Abou-Zleikha, Mohamed; Tan, Zheng-Hua; Christensen, Mads Græsbøll

    2014-01-01

    In audio and speech processing, accurate detection of the changing points between multiple speakers in speech segments is an important stage for several applications such as speaker identification and tracking. Bayesian Information Criteria (BIC)-based approaches are the most traditionally used...... for a certain condition, the model becomes biased to the data used for training limiting the model’s generalisation ability. In this paper, we propose a BIC-based tuning-free approach for speaker segmentation through the use of ensemble-based learning. A forest of segmentation trees is constructed in which each...... tree is trained using a sampled version of the speech segment. During the tree construction process, a set of randomly selected points in the input sequence is examined as potential segmentation points. The point that yields the highest ΔBIC is chosen and the same process is repeated for the resultant...

  11. Data delivery method based on neighbor nodes' information in a mobile ad hoc network.

    Science.gov (United States)

    Kashihara, Shigeru; Hayashi, Takuma; Taenaka, Yuzo; Okuda, Takeshi; Yamaguchi, Suguru

    2014-01-01

    This paper proposes a data delivery method based on neighbor nodes' information to achieve reliable communication in a mobile ad hoc network (MANET). In a MANET, it is difficult to deliver data reliably due to instabilities in network topology and wireless network condition which result from node movement. To overcome such unstable communication, opportunistic routing and network coding schemes have lately attracted considerable attention. Although an existing method that employs such schemes, MAC-independent opportunistic routing and encoding (MORE), Chachulski et al. (2007), improves the efficiency of data delivery in an unstable wireless mesh network, it does not address node movement. To efficiently deliver data in a MANET, the method proposed in this paper thus first employs the same opportunistic routing and network coding used in MORE and also uses the location information and transmission probabilities of neighbor nodes to adapt to changeable network topology and wireless network condition. The simulation experiments showed that the proposed method can achieve efficient data delivery with low network load when the movement speed is relatively slow.

  12. Data Delivery Method Based on Neighbor Nodes’ Information in a Mobile Ad Hoc Network

    Directory of Open Access Journals (Sweden)

    Shigeru Kashihara

    2014-01-01

    Full Text Available This paper proposes a data delivery method based on neighbor nodes’ information to achieve reliable communication in a mobile ad hoc network (MANET. In a MANET, it is difficult to deliver data reliably due to instabilities in network topology and wireless network condition which result from node movement. To overcome such unstable communication, opportunistic routing and network coding schemes have lately attracted considerable attention. Although an existing method that employs such schemes, MAC-independent opportunistic routing and encoding (MORE, Chachulski et al. (2007, improves the efficiency of data delivery in an unstable wireless mesh network, it does not address node movement. To efficiently deliver data in a MANET, the method proposed in this paper thus first employs the same opportunistic routing and network coding used in MORE and also uses the location information and transmission probabilities of neighbor nodes to adapt to changeable network topology and wireless network condition. The simulation experiments showed that the proposed method can achieve efficient data delivery with low network load when the movement speed is relatively slow.

  13. Genetics and phylogeny of genus Coilia in China based on AFLP markers

    Science.gov (United States)

    Yang, Qiaoli; Han, Zhiqiang; Sun, Dianrong; Xie, Songguang; Lin, Longshan; Gao, Tianxiang

    2010-07-01

    The taxonomy of Coilia has been extensively studied in China, and yet phylogenetic relationships among component taxa remain controversial. We used a PCR-based fingerprinting technique, amplified fragment length polymorphism (AFLP) to characterize and identify all four species of Coilia in China. We examined the genetic relationships of the four species of Coilia and a subspecies of Coilia nasus with AFLP. A total of 180 AFLP loci were generated from six primer combinations, of which 76.11% were polymorphic. The mean genetic distance between pairs of taxa ranged from 0.047 to 0.596. The neighbor-joining tree and UPGMA dendrogram resolved the investigated species into three separate lineages: (1) C. mystus, (2) C. grayii and (3) C. brachygnathus, C. nasus, and C. nasus taihuensis. Phylogenetic analysis of the AFLP data is inconsistent with current morphological taxonomic systems. The AFLP data indicated a close relationship among C. brachygnathus, C. nasus taihuensis, and C. nasus. Therefore, the two species described under Coilia ( C. brachygnathus and C. nasus taihuensis) are treated as synonyms of C. nasus.

  14. In-Network Processing of an Iceberg Join Query in Wireless Sensor Networks Based on 2-Way Fragment Semijoins

    Directory of Open Access Journals (Sweden)

    Hyunchul Kang

    2015-03-01

    Full Text Available We investigate the in-network processing of an iceberg join query in wireless sensor networks (WSNs. An iceberg join is a special type of join where only those joined tuples whose cardinality exceeds a certain threshold (called iceberg threshold are qualified for the result. Processing such a join involves the value matching for the join predicate as well as the checking of the cardinality constraint for the iceberg threshold. In the previous scheme, the value matching is carried out as the main task for filtering non-joinable tuples while the iceberg threshold is treated as an additional constraint. We take an alternative approach, meeting the cardinality constraint first and matching values next. In this approach, with a logical fragmentation of the join operand relations on the aggregate counts of the joining attribute values, the optimal sequence of 2-way fragment semijoins is generated, where each fragment semijoin employs a Bloom filter as a synopsis of the joining attribute values. This sequence filters non-joinable tuples in an energy-efficient way in WSNs. Through implementation and a set of detailed experiments, we show that our alternative approach considerably outperforms the previous one.

  15. In-Network Processing of an Iceberg Join Query in Wireless Sensor Networks Based on 2-Way Fragment Semijoins

    Science.gov (United States)

    Kang, Hyunchul

    2015-01-01

    We investigate the in-network processing of an iceberg join query in wireless sensor networks (WSNs). An iceberg join is a special type of join where only those joined tuples whose cardinality exceeds a certain threshold (called iceberg threshold) are qualified for the result. Processing such a join involves the value matching for the join predicate as well as the checking of the cardinality constraint for the iceberg threshold. In the previous scheme, the value matching is carried out as the main task for filtering non-joinable tuples while the iceberg threshold is treated as an additional constraint. We take an alternative approach, meeting the cardinality constraint first and matching values next. In this approach, with a logical fragmentation of the join operand relations on the aggregate counts of the joining attribute values, the optimal sequence of 2-way fragment semijoins is generated, where each fragment semijoin employs a Bloom filter as a synopsis of the joining attribute values. This sequence filters non-joinable tuples in an energy-efficient way in WSNs. Through implementation and a set of detailed experiments, we show that our alternative approach considerably outperforms the previous one. PMID:25774710

  16. Transforming phylogenetic networks: Moving beyond tree space.

    Science.gov (United States)

    Huber, Katharina T; Moulton, Vincent; Wu, Taoyang

    2016-09-07

    Phylogenetic networks are a generalization of phylogenetic trees that are used to represent reticulate evolution. Unrooted phylogenetic networks form a special class of such networks, which naturally generalize unrooted phylogenetic trees. In this paper we define two operations on unrooted phylogenetic networks, one of which is a generalization of the well-known nearest-neighbor interchange (NNI) operation on phylogenetic trees. We show that any unrooted phylogenetic network can be transformed into any other such network using only these operations. This generalizes the well-known fact that any phylogenetic tree can be transformed into any other such tree using only NNI operations. It also allows us to define a generalization of tree space and to define some new metrics on unrooted phylogenetic networks. To prove our main results, we employ some fascinating new connections between phylogenetic networks and cubic graphs that we have recently discovered. Our results should be useful in developing new strategies to search for optimal phylogenetic networks, a topic that has recently generated some interest in the literature, as well as for providing new ways to compare networks. Copyright © 2016 Elsevier Ltd. All rights reserved.

  17. Monitoring individual tree-based change with airborne lidar.

    Science.gov (United States)

    Duncanson, Laura; Dubayah, Ralph

    2018-05-01

    Understanding the carbon flux of forests is critical for constraining the global carbon cycle and managing forests to mitigate climate change. Monitoring forest growth and mortality rates is critical to this effort, but has been limited in the past, with estimates relying primarily on field surveys. Advances in remote sensing enable the potential to monitor tree growth and mortality across landscapes. This work presents an approach to measure tree growth and loss using multidate lidar campaigns in a high-biomass forest in California, USA. Individual tree crowns were delineated in 2008 and again in 2013 using a 3D crown segmentation algorithm, with derived heights and crown radii extracted and used to estimate individual tree aboveground biomass. Tree growth, loss, and aboveground biomass were analyzed with respect to tree height and crown radius. Both tree growth and loss rates decrease with increasing tree height, following the expectation that trees slow in growth rate as they age. Additionally, our aboveground biomass analysis suggests that, while the system is a net source of aboveground carbon, these carbon dynamics are governed by size class with the largest sources coming from the loss of a relatively small number of large individuals. This study demonstrates that monitoring individual tree-based growth and loss can be conducted with multidate airborne lidar, but these methods remain relatively immature. Disparities between lidar acquisitions were particularly difficult to overcome and decreased the sample of trees analyzed for growth rate in this study to 21% of the full number of delineated crowns. However, this study illuminates the potential of airborne remote sensing for ecologically meaningful forest monitoring at an individual tree level. As methods continue to improve, airborne multidate lidar will enable a richer understanding of the drivers of tree growth, loss, and aboveground carbon flux.

  18. FCNN-MR: A Parallel Instance Selection Method Based on Fast Condensed Nearest Neighbor Rule

    OpenAIRE

    Lu Si; Jie Yu; Shasha Li; Jun Ma; Lei Luo; Qingbo Wu; Yongqi Ma; Zhengji Liu

    2017-01-01

    Instance selection (IS) technique is used to reduce the data size to improve the performance of data mining methods. Recently, to process very large data set, several proposed methods divide the training set into some disjoint subsets and apply IS algorithms independently to each subset. In this paper, we analyze the limitation of these methods and give our viewpoint about how to divide and conquer in IS procedure. Then, based on fast condensed nearest neighbor (FCNN) rul...

  19. Summary of Dissimilar Metal Joining Trials Conducted by Edison Welding Institute

    Energy Technology Data Exchange (ETDEWEB)

    MJ Lambert

    2005-11-18

    Under the direction of the NASA-Glenn Research Center, the Edison Welding Institute (EWI) in Columbus, OH performed a series of non-fusion joining experiments to determine the feasibility of joining refractory metals or refractory metal alloys to Ni-based superalloys. Results, as reported by EWI, can be found in the project report for EWI Project 48819GTH (Attachment A, at the end of this document), dated October 10, 2005. The three joining methods used in this investigation were inertia welding, magnetic pulse welding, and electro-spark deposition joining. Five materials were used in these experiments: Mo-47Re, T-111, Hastelloy X, Mar M-247 (coarse-grained, 0.5 mm to several millimeter average grain size), and Mar M-247 (fine-grained, approximately 50 {micro}m average grain size). Several iterative trials of each material combination with each joining method were performed to determine the best practice joining method. Mo-47Re was found to be joined easily to Hastelloy X via inertia welding, but inertia welding of the Mo-alloy to both Mar M-247 alloys resulted in inconsistent joint strength and large reaction layers between the two metals. T-111 was found to join well to Hastelloy X and coarse-grained Mar M-247 via inertia welding, but joining to fine-grained Mar M-247 resulted in low joint strength. Magnetic pulse welding (MPW) was only successful in joining T-111 tubing to Hastelloy X bar stock. The joint integrity and reaction layer between the metals were found to be acceptable. This single joining trial, however, caused damage to the electromagnetic concentrators used in this process. Subsequent design efforts to eliminate the problem resulted in a loss of power imparted to the accelerating work piece, and results could not be reproduced. Welding trials of Mar M-247 to T-111 resulted in catastrophic failure of the bar stock, even at lower power. Electro-spark deposition joining of Mo-47Re, in which the deposited material was Hastelloy X, did not have a

  20. Summary of Dissimilar Metal Joining Trials Conducted by Edison Welding Institute

    International Nuclear Information System (INIS)

    MJ Lambert

    2005-01-01

    Under the direction of the NASA-Glenn Research Center, the Edison Welding Institute (EWI) in Columbus, OH performed a series of non-fusion joining experiments to determine the feasibility of joining refractory metals or refractory metal alloys to Ni-based superalloys. Results, as reported by EWI, can be found in the project report for EWI Project 48819GTH (Attachment A, at the end of this document), dated October 10, 2005. The three joining methods used in this investigation were inertia welding, magnetic pulse welding, and electro-spark deposition joining. Five materials were used in these experiments: Mo-47Re, T-111, Hastelloy X, Mar M-247 (coarse-grained, 0.5 mm to several millimeter average grain size), and Mar M-247 (fine-grained, approximately 50 (micro)m average grain size). Several iterative trials of each material combination with each joining method were performed to determine the best practice joining method. Mo-47Re was found to be joined easily to Hastelloy X via inertia welding, but inertia welding of the Mo-alloy to both Mar M-247 alloys resulted in inconsistent joint strength and large reaction layers between the two metals. T-111 was found to join well to Hastelloy X and coarse-grained Mar M-247 via inertia welding, but joining to fine-grained Mar M-247 resulted in low joint strength. Magnetic pulse welding (MPW) was only successful in joining T-111 tubing to Hastelloy X bar stock. The joint integrity and reaction layer between the metals were found to be acceptable. This single joining trial, however, caused damage to the electromagnetic concentrators used in this process. Subsequent design efforts to eliminate the problem resulted in a loss of power imparted to the accelerating work piece, and results could not be reproduced. Welding trials of Mar M-247 to T-111 resulted in catastrophic failure of the bar stock, even at lower power. Electro-spark deposition joining of Mo-47Re, in which the deposited material was Hastelloy X, did not have a

  1. Welding and Joining of Titanium Aluminides

    Science.gov (United States)

    Cao, Jian; Qi, Junlei; Song, Xiaoguo; Feng, Jicai

    2014-01-01

    Welding and joining of titanium aluminides is the key to making them more attractive in industrial fields. The purpose of this review is to provide a comprehensive overview of recent progress in welding and joining of titanium aluminides, as well as to introduce current research and application. The possible methods available for titanium aluminides involve brazing, diffusion bonding, fusion welding, friction welding and reactive joining. Of the numerous methods, solid-state diffusion bonding and vacuum brazing have been most heavily investigated for producing reliable joints. The current state of understanding and development of every welding and joining method for titanium aluminides is addressed respectively. The focus is on the fundamental understanding of microstructure characteristics and processing–microstructure–property relationships in the welding and joining of titanium aluminides to themselves and to other materials. PMID:28788113

  2. Development of reconstitution method for surveillance specimens using surface activated joining

    Energy Technology Data Exchange (ETDEWEB)

    Nakamura, Terumi; Kaihara, Shoichiro; Yoshida, Kazuo; Sato, Akira [Ishikawajima-Harima Heavy Industries Co. Ltd., Tokyo (Japan); Onizawa, Kunio; Nishiyama, Yutaka; Fukaya, Kiyoshi; Suzuki, Masahide

    1996-03-01

    Evaluation of embrittlement of reactor vessel steel due to irradiation requires surveillance tests. However, many surveillance specimens are necessary for nuclear plants life extension. Therefore, a specimen reconstitution technique has become important to provide the many specimens for continued surveillance. A surface activated joining (SAJ) method has been developed to join various materials together at low temperatures with little deformation, and is useful to bond irradiated specimens. To assess the validity of this method, Charpy impact tests were carried out, and the characteristics caused by heating during joining were measured. The test results showed the Charpy impact values were almost the same as base materials, and surface activated joining reduced heat affected zone to less than 2 mm. (author).

  3. Algorithmic fault tree construction by component-based system modeling

    International Nuclear Information System (INIS)

    Majdara, Aref; Wakabayashi, Toshio

    2008-01-01

    Computer-aided fault tree generation can be easier, faster and less vulnerable to errors than the conventional manual fault tree construction. In this paper, a new approach for algorithmic fault tree generation is presented. The method mainly consists of a component-based system modeling procedure an a trace-back algorithm for fault tree synthesis. Components, as the building blocks of systems, are modeled using function tables and state transition tables. The proposed method can be used for a wide range of systems with various kinds of components, if an inclusive component database is developed. (author)

  4. Optimizing Neighbor Discovery for Ad hoc Networks based on the Bluetooth PAN Profile

    DEFF Research Database (Denmark)

    Kuijpers, Gerben; Nielsen, Thomas Toftegaard; Prasad, Ramjee

    2002-01-01

    IP layer neighbor discovery mechanisms rely highly on broadcast/multicast capabilities of the underlying link layer. The Bluetooth personal area network (PAN) profile has no native link layer broadcast/multicast capabilities and can only emulate this by repeatedly unicast link layer frames....... This paper introduces a neighbor discovery mechanism that utilizes the resources in the Bluetooth PAN profile more efficient. The performance of the new mechanism is investigated using a IPv6 network simulator and compared with emulated broadcasting. It is shown that the signaling overhead can...

  5. Highly Accurate Tree Models Derived from Terrestrial Laser Scan Data: A Method Description

    Directory of Open Access Journals (Sweden)

    Jan Hackenberg

    2014-05-01

    Full Text Available This paper presents a method for fitting cylinders into a point cloud, derived from a terrestrial laser-scanned tree. Utilizing high scan quality data as the input, the resulting models describe the branching structure of the tree, capable of detecting branches with a diameter smaller than a centimeter. The cylinders are stored as a hierarchical tree-like data structure encapsulating parent-child neighbor relations and incorporating the tree’s direction of growth. This structure enables the efficient extraction of tree components, such as the stem or a single branch. The method was validated both by applying a comparison of the resulting cylinder models with ground truth data and by an analysis between the input point clouds and the models. Tree models were accomplished representing more than 99% of the input point cloud, with an average distance from the cylinder model to the point cloud within sub-millimeter accuracy. After validation, the method was applied to build two allometric models based on 24 tree point clouds as an example of the application. Computation terminated successfully within less than 30 min. For the model predicting the total above ground volume, the coefficient of determination was 0.965, showing the high potential of terrestrial laser-scanning for forest inventories.

  6. IcyTree: rapid browser-based visualization for phylogenetic trees and networks.

    Science.gov (United States)

    Vaughan, Timothy G

    2017-08-01

    IcyTree is an easy-to-use application which can be used to visualize a wide variety of phylogenetic trees and networks. While numerous phylogenetic tree viewers exist already, IcyTree distinguishes itself by being a purely online tool, having a responsive user interface, supporting phylogenetic networks (ancestral recombination graphs in particular), and efficiently drawing trees that include information such as ancestral locations or trait values. IcyTree also provides intuitive panning and zooming utilities that make exploring large phylogenetic trees of many thousands of taxa feasible. IcyTree is a web application and can be accessed directly at http://tgvaughan.github.com/icytree . Currently supported web browsers include Mozilla Firefox and Google Chrome. IcyTree is written entirely in client-side JavaScript (no plugin required) and, once loaded, does not require network access to run. IcyTree is free software, and the source code is made available at http://github.com/tgvaughan/icytree under version 3 of the GNU General Public License. tgvaughan@gmail.com. © The Author(s) 2017. Published by Oxford University Press.

  7. Discrete Discriminant analysis based on tree-structured graphical models

    DEFF Research Database (Denmark)

    Perez de la Cruz, Gonzalo; Eslava, Guillermina

    The purpose of this paper is to illustrate the potential use of discriminant analysis based on tree{structured graphical models for discrete variables. This is done by comparing its empirical performance using estimated error rates for real and simulated data. The results show that discriminant a...... analysis based on tree{structured graphical models is a simple nonlinear method competitive with, and sometimes superior to, other well{known linear methods like those assuming mutual independence between variables and linear logistic regression.......The purpose of this paper is to illustrate the potential use of discriminant analysis based on tree{structured graphical models for discrete variables. This is done by comparing its empirical performance using estimated error rates for real and simulated data. The results show that discriminant...

  8. Welding and Joining of Titanium Aluminides

    Directory of Open Access Journals (Sweden)

    Jian Cao

    2014-06-01

    Full Text Available Welding and joining of titanium aluminides is the key to making them more attractive in industrial fields. The purpose of this review is to provide a comprehensive overview of recent progress in welding and joining of titanium aluminides, as well as to introduce current research and application. The possible methods available for titanium aluminides involve brazing, diffusion bonding, fusion welding, friction welding and reactive joining. Of the numerous methods, solid-state diffusion bonding and vacuum brazing have been most heavily investigated for producing reliable joints. The current state of understanding and development of every welding and joining method for titanium aluminides is addressed respectively. The focus is on the fundamental understanding of microstructure characteristics and processing–microstructure–property relationships in the welding and joining of titanium aluminides to themselves and to other materials.

  9. Circum-Arctic petroleum systems identified using decision-tree chemometrics

    Science.gov (United States)

    Peters, K.E.; Ramos, L.S.; Zumberge, J.E.; Valin, Z.C.; Scotese, C.R.; Gautier, D.L.

    2007-01-01

    Source- and age-related biomarker and isotopic data were measured for more than 1000 crude oil samples from wells and seeps collected above approximately 55??N latitude. A unique, multitiered chemometric (multivariate statistical) decision tree was created that allowed automated classification of 31 genetically distinct circumArctic oil families based on a training set of 622 oil samples. The method, which we call decision-tree chemometrics, uses principal components analysis and multiple tiers of K-nearest neighbor and SIMCA (soft independent modeling of class analogy) models to classify and assign confidence limits for newly acquired oil samples and source rock extracts. Geochemical data for each oil sample were also used to infer the age, lithology, organic matter input, depositional environment, and identity of its source rock. These results demonstrate the value of large petroleum databases where all samples were analyzed using the same procedures and instrumentation. Copyright ?? 2007. The American Association of Petroleum Geologists. All rights reserved.

  10. Depositing Nickel-based Hardfacing to Join Carbon Steel and Cast Iron

    Directory of Open Access Journals (Sweden)

    Tomás Fernández-Columbié

    2016-10-01

    Full Text Available The objective of this investigation is to determine the micro-structural behavior of a joint between cast iron and carbon steel by depositing a nickel-based substrate in the carbon steel. The filler was added through Shielded Metal Arc Welding using Castec 3099 (UTP 8 electrodes while the base materials were joined through Gas Tungsten Arc Welding with ER 70S – A1 bare electrodes. The Schaeffler diagram was used to analyze the chemical composition of the resulting weld beads. The results of the analysis performed on the welded area and the heat influence zone indicated the formation of acicular structures near the welded line when Castec 3099 electrodes are used and the formation of skeletal ferrite on the heat influence zone during the application of this welding process. An austenitic mixture is formed when ER 70S – A1 electrodes are used.

  11. Multi-strategy based quantum cost reduction of linear nearest-neighbor quantum circuit

    Science.gov (United States)

    Tan, Ying-ying; Cheng, Xue-yun; Guan, Zhi-jin; Liu, Yang; Ma, Haiying

    2018-03-01

    With the development of reversible and quantum computing, study of reversible and quantum circuits has also developed rapidly. Due to physical constraints, most quantum circuits require quantum gates to interact on adjacent quantum bits. However, many existing quantum circuits nearest-neighbor have large quantum cost. Therefore, how to effectively reduce quantum cost is becoming a popular research topic. In this paper, we proposed multiple optimization strategies to reduce the quantum cost of the circuit, that is, we reduce quantum cost from MCT gates decomposition, nearest neighbor and circuit simplification, respectively. The experimental results show that the proposed strategies can effectively reduce the quantum cost, and the maximum optimization rate is 30.61% compared to the corresponding results.

  12. Spatial characteristics of tree diameter distributions in a temperate old-growth forest.

    Science.gov (United States)

    Zhang, Chunyu; Wei, Yanbo; Zhao, Xiuhai; von Gadow, Klaus

    2013-01-01

    This contribution identifies spatial characteristics of tree diameter in a temperate forest in north-eastern China, based on a fully censused observational study area covering 500×600 m. Mark correlation analysis with three null hypothesis models was used to determine departure from expectations at different neighborhood distances. Tree positions are clumped at all investigated scales in all 37 studied species, while the diameters of most species are spatially negatively correlated, especially at short distances. Interestingly, all three cases showing short-distance attraction of dbh marks are associated with light-demanding shrub species. The short-distance attraction of dbh marks indicates spatially aggregated cohorts of stems of similar size. The percentage of species showing significant dbh suppression peaked at a 4 m distance under the heterogeneous Poisson model. At scales exceeding the peak distance, the percentage of species showing significant dbh suppression decreases sharply with increasing distances. The evidence from this large observational study shows that some of the variation of the spatial characteristics of tree diameters is related variations of topography and soil chemistry. However, an obvious interpretation of this result is still lacking. Thus, removing competitors surrounding the target trees is an effective way to avoid neighboring competition effects reducing the growth of valuable target trees in forest management practice.

  13. Characteristics of physicians and patients who join team-based primary care practices: evidence from Quebec's Family Medicine Groups.

    Science.gov (United States)

    Coyle, Natalie; Strumpf, Erin; Fiset-Laniel, Julie; Tousignant, Pierre; Roy, Yves

    2014-06-01

    New models of delivering primary care are being implemented in various countries. In Quebec, Family Medicine Groups (FMGs) are a team-based approach to enhance access to, and coordination of, care. We examined whether physicians' and patients' characteristics predicted their participation in this new model of primary care. Using provincial administrative data, we created a population cohort of Quebec's vulnerable patients. We collected data before the advent of FMGs on patients' demographic characteristics, chronic illnesses and health service use, and their physicians' demographics, and practice characteristics. Multivariate regression was used to identify key predictors of joining a FMG among both patients and physicians. Patients who eventually enrolled in a FMG were more likely to be female, reside outside of an urban region, have a lower SES status, have diabetes and congestive heart failure, visit the emergency department for ambulatory sensitive conditions and be hospitalized for any cause. They were also less likely to have hypertension, visit an ambulatory clinic and have a usual provider of care. Physicians who joined a FMG were less likely to be located in urban locations, had fewer years in medical practice, saw more patients in hospital, and had patients with lower morbidity. Physicians' practice characteristics and patients' health status and health care service use were important predictors of joining a FMG. To avoid basing policy decisions on tenuous evidence, policymakers and researchers should account for differential selection into team-based primary health care models. Copyright © 2014. Published by Elsevier Ireland Ltd.

  14. 3D Visualization of Trees Based on a Sphere-Board Model

    Directory of Open Access Journals (Sweden)

    Jiangfeng She

    2018-01-01

    Full Text Available Because of the smooth interaction of tree systems, the billboard and crossed-plane techniques of image-based rendering (IBR have been used for tree visualization for many years. However, both the billboard-based tree model (BBTM and the crossed-plane tree model (CPTM have several notable limitations; for example, they give an impression of slicing when viewed from the top side, and they produce an unimpressive stereoscopic effect and insufficient lighted effects. In this study, a sphere-board-based tree model (SBTM is proposed to eliminate these defects and to improve the final visual effects. Compared with the BBTM or CPTM, the proposed SBTM uses one or more sphere-like 3D geometric surfaces covered with a virtual texture, which can present more details about the foliage than can 2D planes, to represent the 3D outline of a tree crown. However, the profile edge presented by a continuous surface is overly smooth and regular, and when used to delineate the outline of a tree crown, it makes the tree appear very unrealistic. To overcome this shortcoming and achieve a more natural final visual effect of the tree model, an additional process is applied to the edge of the surface profile. In addition, the SBTM can better support lighted effects because of its cubic geometrical features. Interactive visualization effects for a single tree and a grove are presented in a case study of Sabina chinensis. The results show that the SBTM can achieve a better compromise between realism and performance than can the BBTM or CPTM.

  15. Real Time Animation of Trees Based on BBSC in Computer Games

    Directory of Open Access Journals (Sweden)

    Xuefeng Ao

    2009-01-01

    Full Text Available That researchers in the field of computer games usually find it is difficult to simulate the motion of actual 3D model trees lies in the fact that the tree model itself has very complicated structure, and many sophisticated factors need to be considered during the simulation. Though there are some works on simulating 3D tree and its motion, few of them are used in computer games due to the high demand for real-time in computer games. In this paper, an approach of animating trees in computer games based on a novel tree model representation—Ball B-Spline Curves (BBSCs are proposed. By taking advantage of the good features of the BBSC-based model, physical simulation of the motion of leafless trees with wind blowing becomes easier and more efficient. The method can generate realistic 3D tree animation in real-time, which meets the high requirement for real time in computer games.

  16. Joining of SiCf/SiC composites for thermonuclear fusion reactors

    International Nuclear Information System (INIS)

    Ferraris, M.; Badini, C.; Montorsi, M.; Appendino, P.; Scholz, H.W.

    1994-01-01

    Due to their favourable radiological behaviour, SiC f /SiC composites are promising structural materials for future use in fusion reactors. A problem to cope with is the joining of the ceramic composite material (CMC) to itself for more complex structures. Maintenance concepts for a reactor made of SiC f /SiC will demand a method of joining. The joining agents should comply with the low-activation approach of the base material. With the acceptable elements Si and Mg, sandwich structures of composite/metal/composite were prepared in Ar atmosphere at temperatures just above the melting points of the metals. Another promising route is the use of joining agents of boro-silicate glasses: their composition can be tailored to obtain softening temperatures of interest for fusion applications. The glassy joint can be easily ceramised to improve thermomechanical properties. The joining interfaces were investigated by SEM-EDS, XRD and mechanical tests. ((orig.))

  17. Estimation of Tree Cover in an Agricultural Parkland of Senegal Using Rule-Based Regression Tree Modeling

    Directory of Open Access Journals (Sweden)

    Stefanie M. Herrmann

    2013-10-01

    Full Text Available Field trees are an integral part of the farmed parkland landscape in West Africa and provide multiple benefits to the local environment and livelihoods. While field trees have received increasing interest in the context of strengthening resilience to climate variability and change, the actual extent of farmed parkland and spatial patterns of tree cover are largely unknown. We used the rule-based predictive modeling tool Cubist® to estimate field tree cover in the west-central agricultural region of Senegal. A collection of rules and associated multiple linear regression models was constructed from (1 a reference dataset of percent tree cover derived from very high spatial resolution data (2 m Orbview as the dependent variable, and (2 ten years of 10-day 250 m Moderate Resolution Imaging Spectrometer (MODIS Normalized Difference Vegetation Index (NDVI composites and derived phenological metrics as independent variables. Correlation coefficients between modeled and reference percent tree cover of 0.88 and 0.77 were achieved for training and validation data respectively, with absolute mean errors of 1.07 and 1.03 percent tree cover. The resulting map shows a west-east gradient from high tree cover in the peri-urban areas of horticulture and arboriculture to low tree cover in the more sparsely populated eastern part of the study area. A comparison of current (2000s tree cover along this gradient with historic cover as seen on Corona images reveals dynamics of change but also areas of remarkable stability of field tree cover since 1968. The proposed modeling approach can help to identify locations of high and low tree cover in dryland environments and guide ground studies and management interventions aimed at promoting the integration of field trees in agricultural systems.

  18. Application of Goal Tree-Success Tree model as the knowledge-base of operator advisory systems

    International Nuclear Information System (INIS)

    Kim, I.S.; Modarres, M.

    1987-01-01

    The most important portion of an expert system development is the articulation of knowledge by the expert and its satisfactory formulation in a suitable knowledge representation scheme for mechanization by a computer. A 'deep knowledge' approach called Goal Tree-Success Tree model is devised to represent complex dynamic domain knowledge. This approach can hierarchically model the underlying principles of a given process domain (for example nuclear power plant operations domain). The Goal Tree-Success Tree can then be used to represent the knowledge-base and provide means of selecting an efficient search routine in the inference engine of an expert system. A prototype expert system has been developed to demonstrate the method. This expert system models the operation of a typical system used in the pressurized water reactors. The expert system is modeled for real-time operations if an interface between plant parameters and the expert system is established. The real-time operation provides an ability to quickly remedy minor disturbances that can quickly lead to a system malfunction or trip. A description of both the Goal Tree-Success Tree model and the prototype expert system is presented. (orig.)

  19. An Isometric Mapping Based Co-Location Decision Tree Algorithm

    Science.gov (United States)

    Zhou, G.; Wei, J.; Zhou, X.; Zhang, R.; Huang, W.; Sha, H.; Chen, J.

    2018-05-01

    Decision tree (DT) induction has been widely used in different pattern classification. However, most traditional DTs have the disadvantage that they consider only non-spatial attributes (ie, spectral information) as a result of classifying pixels, which can result in objects being misclassified. Therefore, some researchers have proposed a co-location decision tree (Cl-DT) method, which combines co-location and decision tree to solve the above the above-mentioned traditional decision tree problems. Cl-DT overcomes the shortcomings of the existing DT algorithms, which create a node for each value of a given attribute, which has a higher accuracy than the existing decision tree approach. However, for non-linearly distributed data instances, the euclidean distance between instances does not reflect the true positional relationship between them. In order to overcome these shortcomings, this paper proposes an isometric mapping method based on Cl-DT (called, (Isomap-based Cl-DT), which is a method that combines heterogeneous and Cl-DT together. Because isometric mapping methods use geodetic distances instead of Euclidean distances between non-linearly distributed instances, the true distance between instances can be reflected. The experimental results and several comparative analyzes show that: (1) The extraction method of exposed carbonate rocks is of high accuracy. (2) The proposed method has many advantages, because the total number of nodes, the number of leaf nodes and the number of nodes are greatly reduced compared to Cl-DT. Therefore, the Isomap -based Cl-DT algorithm can construct a more accurate and faster decision tree.

  20. AN ISOMETRIC MAPPING BASED CO-LOCATION DECISION TREE ALGORITHM

    Directory of Open Access Journals (Sweden)

    G. Zhou

    2018-05-01

    Full Text Available Decision tree (DT induction has been widely used in different pattern classification. However, most traditional DTs have the disadvantage that they consider only non-spatial attributes (ie, spectral information as a result of classifying pixels, which can result in objects being misclassified. Therefore, some researchers have proposed a co-location decision tree (Cl-DT method, which combines co-location and decision tree to solve the above the above-mentioned traditional decision tree problems. Cl-DT overcomes the shortcomings of the existing DT algorithms, which create a node for each value of a given attribute, which has a higher accuracy than the existing decision tree approach. However, for non-linearly distributed data instances, the euclidean distance between instances does not reflect the true positional relationship between them. In order to overcome these shortcomings, this paper proposes an isometric mapping method based on Cl-DT (called, (Isomap-based Cl-DT, which is a method that combines heterogeneous and Cl-DT together. Because isometric mapping methods use geodetic distances instead of Euclidean distances between non-linearly distributed instances, the true distance between instances can be reflected. The experimental results and several comparative analyzes show that: (1 The extraction method of exposed carbonate rocks is of high accuracy. (2 The proposed method has many advantages, because the total number of nodes, the number of leaf nodes and the number of nodes are greatly reduced compared to Cl-DT. Therefore, the Isomap -based Cl-DT algorithm can construct a more accurate and faster decision tree.

  1. A multilevel-skin neighbor list algorithm for molecular dynamics simulation

    Science.gov (United States)

    Zhang, Chenglong; Zhao, Mingcan; Hou, Chaofeng; Ge, Wei

    2018-01-01

    Searching of the interaction pairs and organization of the interaction processes are important steps in molecular dynamics (MD) algorithms and are critical to the overall efficiency of the simulation. Neighbor lists are widely used for these steps, where thicker skin can reduce the frequency of list updating but is discounted by more computation in distance check for the particle pairs. In this paper, we propose a new neighbor-list-based algorithm with a precisely designed multilevel skin which can reduce unnecessary computation on inter-particle distances. The performance advantages over traditional methods are then analyzed against the main simulation parameters on Intel CPUs and MICs (many integrated cores), and are clearly demonstrated. The algorithm can be generalized for various discrete simulations using neighbor lists.

  2. Model of directed lines for square ice with second-neighbor and third-neighbor interactions

    Science.gov (United States)

    Kirov, Mikhail V.

    2018-02-01

    The investigation of the properties of nanoconfined systems is one of the most rapidly developing scientific fields. Recently it has been established that water monolayer between two graphene sheets forms square ice. Because of the energetic disadvantage, in the structure of the square ice there are no longitudinally arranged molecules. The result is that the structure is formed by unidirectional straight-lines of hydrogen bonds only. A simple but accurate discrete model of square ice with second-neighbor and third-neighbor interactions is proposed. According to this model, the ground state includes all configurations which do not contain three neighboring unidirectional chains of hydrogen bonds. Each triplet increases the energy by the same value. This new model differs from an analogous model with long-range interactions where in the ground state all neighboring chains are antiparallel. The new model is suitable for the corresponding system of point electric (and magnetic) dipoles on the square lattice. It allows separately estimating the different contributions to the total binding energy and helps to understand the properties of infinite monolayers and finite nanostructures. Calculations of the binding energy for square ice and for point dipole system are performed using the packages TINKER and LAMMPS.

  3. Frugivores bias seed-adult tree associations through nonrandom seed dispersal: a phylogenetic approach.

    Science.gov (United States)

    Razafindratsima, Onja H; Dunham, Amy E

    2016-08-01

    Frugivores are the main seed dispersers in many ecosystems, such that behaviorally driven, nonrandom patterns of seed dispersal are a common process; but patterns are poorly understood. Characterizing these patterns may be essential for understanding spatial organization of fruiting trees and drivers of seed-dispersal limitation in biodiverse forests. To address this, we studied resulting spatial associations between dispersed seeds and adult tree neighbors in a diverse rainforest in Madagascar, using a temporal and phylogenetic approach. Data show that by using fruiting trees as seed-dispersal foci, frugivores bias seed dispersal under conspecific adults and under heterospecific trees that share dispersers and fruiting time with the dispersed species. Frugivore-mediated seed dispersal also resulted in nonrandom phylogenetic associations of dispersed seeds with their nearest adult neighbors, in nine out of the 16 months of our study. However, these nonrandom phylogenetic associations fluctuated unpredictably over time, ranging from clustered to overdispersed. The spatial and phylogenetic template of seed dispersal did not translate to similar patterns of association in adult tree neighborhoods, suggesting the importance of post-dispersal processes in structuring plant communities. Results suggest that frugivore-mediated seed dispersal is important for structuring early stages of plant-plant associations, setting the template for post-dispersal processes that influence ultimate patterns of plant recruitment. Importantly, if biased patterns of dispersal are common in other systems, frugivores may promote tree coexistence in biodiverse forests by limiting the frequency and diversity of heterospecific interactions of seeds they disperse. © 2016 by the Ecological Society of America.

  4. Error Analysis for RADAR Neighbor Matching Localization in Linear Logarithmic Strength Varying Wi-Fi Environment

    Directory of Open Access Journals (Sweden)

    Mu Zhou

    2014-01-01

    Full Text Available This paper studies the statistical errors for the fingerprint-based RADAR neighbor matching localization with the linearly calibrated reference points (RPs in logarithmic received signal strength (RSS varying Wi-Fi environment. To the best of our knowledge, little comprehensive analysis work has appeared on the error performance of neighbor matching localization with respect to the deployment of RPs. However, in order to achieve the efficient and reliable location-based services (LBSs as well as the ubiquitous context-awareness in Wi-Fi environment, much attention has to be paid to the highly accurate and cost-efficient localization systems. To this end, the statistical errors by the widely used neighbor matching localization are significantly discussed in this paper to examine the inherent mathematical relations between the localization errors and the locations of RPs by using a basic linear logarithmic strength varying model. Furthermore, based on the mathematical demonstrations and some testing results, the closed-form solutions to the statistical errors by RADAR neighbor matching localization can be an effective tool to explore alternative deployment of fingerprint-based neighbor matching localization systems in the future.

  5. Error Analysis for RADAR Neighbor Matching Localization in Linear Logarithmic Strength Varying Wi-Fi Environment

    Science.gov (United States)

    Tian, Zengshan; Xu, Kunjie; Yu, Xiang

    2014-01-01

    This paper studies the statistical errors for the fingerprint-based RADAR neighbor matching localization with the linearly calibrated reference points (RPs) in logarithmic received signal strength (RSS) varying Wi-Fi environment. To the best of our knowledge, little comprehensive analysis work has appeared on the error performance of neighbor matching localization with respect to the deployment of RPs. However, in order to achieve the efficient and reliable location-based services (LBSs) as well as the ubiquitous context-awareness in Wi-Fi environment, much attention has to be paid to the highly accurate and cost-efficient localization systems. To this end, the statistical errors by the widely used neighbor matching localization are significantly discussed in this paper to examine the inherent mathematical relations between the localization errors and the locations of RPs by using a basic linear logarithmic strength varying model. Furthermore, based on the mathematical demonstrations and some testing results, the closed-form solutions to the statistical errors by RADAR neighbor matching localization can be an effective tool to explore alternative deployment of fingerprint-based neighbor matching localization systems in the future. PMID:24683349

  6. Generalising tree traversals and tree transformations to DAGs

    DEFF Research Database (Denmark)

    Bahr, Patrick; Axelsson, Emil

    2017-01-01

    We present a recursion scheme based on attribute grammars that can be transparently applied to trees and acyclic graphs. Our recursion scheme allows the programmer to implement a tree traversal or a tree transformation and then apply it to compact graph representations of trees instead. The resul......We present a recursion scheme based on attribute grammars that can be transparently applied to trees and acyclic graphs. Our recursion scheme allows the programmer to implement a tree traversal or a tree transformation and then apply it to compact graph representations of trees instead...... as the complementing theory with a number of examples....

  7. The development of joining doped graphite to copper for first wall application in HT-7 tokamak

    Energy Technology Data Exchange (ETDEWEB)

    Zhou Zhangjian, E-mail: zhouzhj@mater.ustb.edu.cn [School of Materials Science and Engineering, University of Science and Technology Beijing, Beijing 100083 (China); Zhong Zhihong [School of Materials Science and Engineering, University of Science and Technology Beijing, Beijing 100083 (China); Chen Junling [Institute of Plasma Physics, Chinese Academy of Sciences, Hefei, Anhui 230031 (China); Ge Changchun [School of Materials Science and Engineering, University of Science and Technology Beijing, Beijing 100083 (China)

    2010-12-15

    Two joining methods have been developed for joining carbon based plasma facing material to copper based heat sink material for the potential application in HT-7 and EAST tokamak. The first joining method is based on brazing technique by using a rapidly solidified foil-type Ti-Zr based amorphous filler with a melting temperature of 850 deg. C. The other joining method is direct active metal casting-casting the premixed powders of copper and active transition metals on the mechanical machined carbon surface directly. SEM observations demonstrate high quality of joining surface for both joints. The brazing technique is more promising for fabrication joint with larger size compared with the direct active alloy casting method. High heat flux test using an e-beam device was performed on the actively cooled C/Cu joint fabricated by brazing method. There has no damage occurred on the joint after heat loading at 6 MW/m{sup 2}.

  8. EM for phylogenetic topology reconstruction on nonhomogeneous data.

    Science.gov (United States)

    Ibáñez-Marcelo, Esther; Casanellas, Marta

    2014-06-17

    The reconstruction of the phylogenetic tree topology of four taxa is, still nowadays, one of the main challenges in phylogenetics. Its difficulties lie in considering not too restrictive evolutionary models, and correctly dealing with the long-branch attraction problem. The correct reconstruction of 4-taxon trees is crucial for making quartet-based methods work and being able to recover large phylogenies. We adapt the well known expectation-maximization algorithm to evolutionary Markov models on phylogenetic 4-taxon trees. We then use this algorithm to estimate the substitution parameters, compute the corresponding likelihood, and to infer the most likely quartet. In this paper we consider an expectation-maximization method for maximizing the likelihood of (time nonhomogeneous) evolutionary Markov models on trees. We study its success on reconstructing 4-taxon topologies and its performance as input method in quartet-based phylogenetic reconstruction methods such as QFIT and QuartetSuite. Our results show that the method proposed here outperforms neighbor-joining and the usual (time-homogeneous continuous-time) maximum likelihood methods on 4-leaved trees with among-lineage instantaneous rate heterogeneity, and perform similarly to usual continuous-time maximum-likelihood when data satisfies the assumptions of both methods. The method presented in this paper is well suited for reconstructing the topology of any number of taxa via quartet-based methods and is highly accurate, specially regarding largely divergent trees and time nonhomogeneous data.

  9. Clustered K nearest neighbor algorithm for daily inflow forecasting

    NARCIS (Netherlands)

    Akbari, M.; Van Overloop, P.J.A.T.M.; Afshar, A.

    2010-01-01

    Instance based learning (IBL) algorithms are a common choice among data driven algorithms for inflow forecasting. They are based on the similarity principle and prediction is made by the finite number of similar neighbors. In this sense, the similarity of a query instance is estimated according to

  10. Trajectory similarity join in spatial networks

    KAUST Repository

    Shang, Shuo

    2017-09-07

    The matching of similar pairs of objects, called similarity join, is fundamental functionality in data management. We consider the case of trajectory similarity join (TS-Join), where the objects are trajectories of vehicles moving in road networks. Thus, given two sets of trajectories and a threshold θ, the TS-Join returns all pairs of trajectories from the two sets with similarity above θ. This join targets applications such as trajectory near-duplicate detection, data cleaning, ridesharing recommendation, and traffic congestion prediction. With these applications in mind, we provide a purposeful definition of similarity. To enable efficient TS-Join processing on large sets of trajectories, we develop search space pruning techniques and take into account the parallel processing capabilities of modern processors. Specifically, we present a two-phase divide-and-conquer algorithm. For each trajectory, the algorithm first finds similar trajectories. Then it merges the results to achieve a final result. The algorithm exploits an upper bound on the spatiotemporal similarity and a heuristic scheduling strategy for search space pruning. The algorithm\\'s per-trajectory searches are independent of each other and can be performed in parallel, and the merging has constant cost. An empirical study with real data offers insight in the performance of the algorithm and demonstrates that is capable of outperforming a well-designed baseline algorithm by an order of magnitude.

  11. Phylogenetic inferences of Nepenthes species in Peninsular Malaysia revealed by chloroplast (trnL intron) and nuclear (ITS) DNA sequences

    OpenAIRE

    Bunawan, Hamidun; Yen, Choong Chee; Yaakop, Salmah; Noor, Normah Mohd

    2017-01-01

    Background The chloroplastic trnL intron and the nuclear internal transcribed spacer (ITS) region were sequenced for 11 Nepenthes species recorded in Peninsular Malaysia to examine their phylogenetic relationship and to evaluate the usage of trnL intron and ITS sequences for phylogenetic reconstruction of this genus. Results Phylogeny reconstruction was carried out using neighbor-joining, maximum parsimony and Bayesian analyses. All the trees revealed two major clusters, a lowland group consi...

  12. Willmore energy for joining of carbon nanostructures

    Science.gov (United States)

    Sripaturad, P.; Alshammari, N. A.; Thamwattana, N.; McCoy, J. A.; Baowan, D.

    2018-06-01

    Numerous types of carbon nanostructure have been found experimentally, including nanotubes, fullerenes and nanocones. These structures have applications in various nanoscale devices and the joining of these structures may lead to further new configurations with more remarkable properties and applications. The join profile between different carbon nanostructures in a symmetric configuration may be modelled using the calculus of variations. In previous studies, carbon nanostructures were assumed to deform according to perfect elasticity, thus the elastic energy, depending only on the axial curvature, was used to determine the join profile consisting of a finite number of discrete bonds. However, one could argue that the relevant energy should also involve the rotational curvature, especially when its size is comparable to the axial curvature. In this paper, we use the Willmore energy, a natural generalisation of the elastic energy that depends on both the axial and rotational curvatures. Catenoids are absolute minimisers of this energy and pieces of these may be used to join various nanostructures. We focus on the cases of joining a fullerene to a nanotube and joining two fullerenes along a common axis. By comparing our results with the earlier work, we find that both energies give similar joining profiles. Further work on other configurations may reveal which energy provides a better model.

  13. Haldane to Dimer Phase Transition in the Spin-1 Haldane System with Bond-Alternating Nearest-Neighbor and Uniform Next-Nearest-Neighbor Exchange Interactions

    OpenAIRE

    Takashi, Tonegawa; Makoto, Kaburagi; Takeshi, Nakao; Department of Physics, Faculty of Science, Kobe University; Faculty of Cross-Cultural Studies, Kobe University; Department of Physics, Faculty of Science, Kobe University

    1995-01-01

    The Haldane to dimer phase transition is studied in the spin-1 Haldane system with bond-alternating nearest-neighbor and uniform next-nearest-neighbor exchange interactions, where both interactions are antiferromagnetic and thus compete with each other. By using a method of exact diagonalization, the ground-state phase diagram on the ratio of the next-nearest-neighbor interaction constant to the nearest-neighbor one versus the bond-alternation parameter of the nearest-neighbor interactions is...

  14. Effect of Ti and Si interlayer materials on the joining of SiC ceramics

    Energy Technology Data Exchange (ETDEWEB)

    Jung, Yang Il; Park, Jung Hwan; Kim, Hyun Gil; Park, Dong Jun; Park, Jeong Yong; Kim, Weon Ju [LWR Fuel Technology Division, Korea Atomic Energy Research Institute, Daejeon (Korea, Republic of)

    2016-08-15

    SiC-based ceramic composites are currently being considered for use in fuel cladding tubes in light-water reactors. The joining of SiC ceramics in a hermetic seal is required for the development of ceramic-based fuel cladding tubes. In this study, SiC monoliths were diffusion bonded using a Ti foil interlayer and additional Si powder. In the joining process, a very low uniaxial pressure of ∼0.1 MPa was applied, so the process is applicable for joining thin-walled long tubes. The joining strength depended strongly on the type of SiC material. Reaction-bonded SiC (RB-SiC) showed a higher joining strength than sintered SiC because the diffusion reaction of Si was promoted in the former. The joining strength of sintered SiC was increased by the addition of Si at the Ti interlayer to play the role of the free Si in RB-SiC. The maximum joint strength obtained under torsional stress was ∼100 MPa. The joint interface consisted of TiSi{sub 2}, Ti{sub 3}SiC{sub 2}, and SiC phases formed by a diffusion reaction of Ti and Si.

  15. Kinetic Models for Topological Nearest-Neighbor Interactions

    Science.gov (United States)

    Blanchet, Adrien; Degond, Pierre

    2017-12-01

    We consider systems of agents interacting through topological interactions. These have been shown to play an important part in animal and human behavior. Precisely, the system consists of a finite number of particles characterized by their positions and velocities. At random times a randomly chosen particle, the follower, adopts the velocity of its closest neighbor, the leader. We study the limit of a system size going to infinity and, under the assumption of propagation of chaos, show that the limit kinetic equation is a non-standard spatial diffusion equation for the particle distribution function. We also study the case wherein the particles interact with their K closest neighbors and show that the corresponding kinetic equation is the same. Finally, we prove that these models can be seen as a singular limit of the smooth rank-based model previously studied in Blanchet and Degond (J Stat Phys 163:41-60, 2016). The proofs are based on a combinatorial interpretation of the rank as well as some concentration of measure arguments.

  16. MRI-based decision tree model for diagnosis of biliary atresia.

    Science.gov (United States)

    Kim, Yong Hee; Kim, Myung-Joon; Shin, Hyun Joo; Yoon, Haesung; Han, Seok Joo; Koh, Hong; Roh, Yun Ho; Lee, Mi-Jung

    2018-02-23

    To evaluate MRI findings and to generate a decision tree model for diagnosis of biliary atresia (BA) in infants with jaundice. We retrospectively reviewed features of MRI and ultrasonography (US) performed in infants with jaundice between January 2009 and June 2016 under approval of the institutional review board, including the maximum diameter of periportal signal change on MRI (MR triangular cord thickness, MR-TCT) or US (US-TCT), visibility of common bile duct (CBD) and abnormality of gallbladder (GB). Hepatic subcapsular flow was reviewed on Doppler US. We performed conditional inference tree analysis using MRI findings to generate a decision tree model. A total of 208 infants were included, 112 in the BA group and 96 in the non-BA group. Mean age at the time of MRI was 58.7 ± 36.6 days. Visibility of CBD, abnormality of GB and MR-TCT were good discriminators for the diagnosis of BA and the MRI-based decision tree using these findings with MR-TCT cut-off 5.1 mm showed 97.3 % sensitivity, 94.8 % specificity and 96.2 % accuracy. MRI-based decision tree model reliably differentiates BA in infants with jaundice. MRI can be an objective imaging modality for the diagnosis of BA. • MRI-based decision tree model reliably differentiates biliary atresia in neonatal cholestasis. • Common bile duct, gallbladder and periportal signal changes are the discriminators. • MRI has comparable performance to ultrasonography for diagnosis of biliary atresia.

  17. Multiple hypothesis tracking based extraction of airway trees from CT data

    DEFF Research Database (Denmark)

    Raghavendra, Selvan; Petersen, Jens; de Bruijne, Marleen

    Segmentation of airway trees from CT scans of lungs has important clinical applications, in relation to the diagnosis of chronic obstructive pulmonary disease (COPD). Here we present a method based on multiple hypothesis tracking (MHT) and template matching, originally devised for vessel...... segmentation, to extract airway trees. Idealized tubular templates are constructed and ranked using scores assigned based on the image data. Several such regularly spaced hypotheses are used in constructing a hypothesis tree, which is then traversed to obtain improved segmentation results....

  18. Collective Behaviors of Mobile Robots Beyond the Nearest Neighbor Rules With Switching Topology.

    Science.gov (United States)

    Ning, Boda; Han, Qing-Long; Zuo, Zongyu; Jin, Jiong; Zheng, Jinchuan

    2018-05-01

    This paper is concerned with the collective behaviors of robots beyond the nearest neighbor rules, i.e., dispersion and flocking, when robots interact with others by applying an acute angle test (AAT)-based interaction rule. Different from a conventional nearest neighbor rule or its variations, the AAT-based interaction rule allows interactions with some far-neighbors and excludes unnecessary nearest neighbors. The resulting dispersion and flocking hold the advantages of scalability, connectivity, robustness, and effective area coverage. For the dispersion, a spring-like controller is proposed to achieve collision-free coordination. With switching topology, a new fixed-time consensus-based energy function is developed to guarantee the system stability. An upper bound of settling time for energy consensus is obtained, and a uniform time interval is accordingly set so that energy distribution is conducted in a fair manner. For the flocking, based on a class of generalized potential functions taking nonsmooth switching into account, a new controller is proposed to ensure that the same velocity for all robots is eventually reached. A co-optimizing problem is further investigated to accomplish additional tasks, such as enhancing communication performance, while maintaining the collective behaviors of mobile robots. Simulation results are presented to show the effectiveness of the theoretical results.

  19. MICROWAVE JOINING OF ALUMINA CERAMIC AND HYDROXYLAPATITE BIOCERAMIC

    Institute of Scientific and Technical Information of China (English)

    1999-01-01

    Microwave joining is a rapid developmental new techniqu e in recent years.This paper introduces a new microwave joining equipment which was made by our lab,succeeds in alumina ceramic-hydroxylapatite bioceramic j o in in the equipment, and analyzes the join situation of join boundary by using s canni ng electron microscope(SEM),this paper analyzes the mechanism of microwave joini ng also.

  20. Enabling lightweight designs by a new laser based approach for joining aluminum to steel

    Science.gov (United States)

    Brockmann, Rüdiger; Kaufmann, Sebastian; Kirchhoff, Marc; Candel-Ruiz, Antonio; Müllerschön, Oliver; Havrilla, David

    2015-03-01

    As sustainability is an essential requirement, lightweight design becomes more and more important, especially for mobility. Reduced weight ensures more efficient vehicles and enables better environmental impact. Besides the design, new materials and material combinations are one major trend to achieve the required weight savings. The use of Carbon Fiber Reinforced Plastics (abbr. CFRP) is widely discussed, but so far high volume applications are rarely to be found. This is mainly due to the fact that parts made of CFRP are much more expensive than conventional parts. Furthermore, the proper technologies for high volume production are not yet ready. Another material with a large potential for lightweight design is aluminum. In comparison to CFRP, aluminum alloys are generally more affordable. As aluminum is a metallic material, production technologies for high volume standard cutting or joining applications are already developed. In addition, bending and deep-drawing can be applied. In automotive engineering, hybrid structures such as combining high-strength steels with lightweight aluminum alloys retain significant weight reduction but also have an advantage over monolithic aluminum - enhanced behavior in case of crash. Therefore, since the use of steel for applications requiring high mechanical properties is unavoidable, methods for joining aluminum with steel parts have to be further developed. Former studies showed that the use of a laser beam can be a possibility to join aluminum to steel parts. In this sense, the laser welding process represents a major challenge, since both materials have different thermal expansion coefficients and properties related to the behavior in corrosive media. Additionally, brittle intermetallic phases are formed during welding. A promising approach to welding aluminum to steel is based on the use of Laser Metal Deposition (abbr. LMD) with deposit materials in the form of powders. Within the present work, the advantages of this

  1. Maximum likelihood inference of small trees in the presence of long branches.

    Science.gov (United States)

    Parks, Sarah L; Goldman, Nick

    2014-09-01

    The statistical basis of maximum likelihood (ML), its robustness, and the fact that it appears to suffer less from biases lead to it being one of the most popular methods for tree reconstruction. Despite its popularity, very few analytical solutions for ML exist, so biases suffered by ML are not well understood. One possible bias is long branch attraction (LBA), a regularly cited term generally used to describe a propensity for long branches to be joined together in estimated trees. Although initially mentioned in connection with inconsistency of parsimony, LBA has been claimed to affect all major phylogenetic reconstruction methods, including ML. Despite the widespread use of this term in the literature, exactly what LBA is and what may be causing it is poorly understood, even for simple evolutionary models and small model trees. Studies looking at LBA have focused on the effect of two long branches on tree reconstruction. However, to understand the effect of two long branches it is also important to understand the effect of just one long branch. If ML struggles to reconstruct one long branch, then this may have an impact on LBA. In this study, we look at the effect of one long branch on three-taxon tree reconstruction. We show that, counterintuitively, long branches are preferentially placed at the tips of the tree. This can be understood through the use of analytical solutions to the ML equation and distance matrix methods. We go on to look at the placement of two long branches on four-taxon trees, showing that there is no attraction between long branches, but that for extreme branch lengths long branches are joined together disproportionally often. These results illustrate that even small model trees are still interesting to help understand how ML phylogenetic reconstruction works, and that LBA is a complicated phenomenon that deserves further study. © The Author(s) 2014. Published by Oxford University Press, on behalf of the Society of Systematic Biologists.

  2. Prospects of joining multi-material structures

    Science.gov (United States)

    Sankaranarayanan, R.; Hynes, N. Rajesh Jesudoss

    2018-05-01

    Spring up trends and necessities make the pipelines for the brand new Technologies. The same way, Multimaterial structures emerging as fruitful alternatives for the conventional structures in the manufacturing sector. Especially manufacturing of transport vehicles is placing a perfect platform for these new structures. Bonding or joining technology plays a crucial role in the field of manufacturing for sustainability. These latest structures are purely depending on such joining technologies so that multi-material structuring can be possible practically. The real challenge lies on joining dissimilar materials of different properties and nature. Escalation of thermoplastic usage in large structural components also faces similar ambiguity for joining multi-material structures. Adhesive bonding, mechanical fastening and are the answering technologies for multi-material structures. This current paper analysis the prospects of these bonding technologies to meet the challenges of tomorrow.

  3. Tree compression with top trees

    DEFF Research Database (Denmark)

    Bille, Philip; Gørtz, Inge Li; Landau, Gad M.

    2013-01-01

    We introduce a new compression scheme for labeled trees based on top trees [3]. Our compression scheme is the first to simultaneously take advantage of internal repeats in the tree (as opposed to the classical DAG compression that only exploits rooted subtree repeats) while also supporting fast...

  4. Tree compression with top trees

    DEFF Research Database (Denmark)

    Bille, Philip; Gørtz, Inge Li; Landau, Gad M.

    2015-01-01

    We introduce a new compression scheme for labeled trees based on top trees. Our compression scheme is the first to simultaneously take advantage of internal repeats in the tree (as opposed to the classical DAG compression that only exploits rooted subtree repeats) while also supporting fast...

  5. Bridging process-based and empirical approaches to modeling tree growth

    Science.gov (United States)

    Harry T. Valentine; Annikki Makela; Annikki Makela

    2005-01-01

    The gulf between process-based and empirical approaches to modeling tree growth may be bridged, in part, by the use of a common model. To this end, we have formulated a process-based model of tree growth that can be fitted and applied in an empirical mode. The growth model is grounded in pipe model theory and an optimal control model of crown development. Together, the...

  6. A method of neighbor classes based SVM classification for optical printed Chinese character recognition.

    Science.gov (United States)

    Zhang, Jie; Wu, Xiaohong; Yu, Yanmei; Luo, Daisheng

    2013-01-01

    In optical printed Chinese character recognition (OPCCR), many classifiers have been proposed for the recognition. Among the classifiers, support vector machine (SVM) might be the best classifier. However, SVM is a classifier for two classes. When it is used for multi-classes in OPCCR, its computation is time-consuming. Thus, we propose a neighbor classes based SVM (NC-SVM) to reduce the computation consumption of SVM. Experiments of NC-SVM classification for OPCCR have been done. The results of the experiments have shown that the NC-SVM we proposed can effectively reduce the computation time in OPCCR.

  7. A Python-based Interface for Wide Coverage Lexicalized Tree-adjoining Grammars

    Directory of Open Access Journals (Sweden)

    Wang Ziqi

    2015-04-01

    Full Text Available This paper describes the design and implementation of a Python-based interface for wide coverage Lexicalized Tree-adjoining Grammars. The grammars are part of the XTAG Grammar project at the University of Pennsylvania, which were hand-written and semi-automatically curated to parse real-world corpora. We provide an interface to the wide coverage English and Korean XTAG grammars. Each XTAG grammar is lexicalized, which means at least one word selects a tree fragment (called an elementary tree or etree. Derivations for sentences are built by combining etrees using substitution (replacement of a tree node with an etree at the frontier of another etree and adjunction (replacement of an internal tree node in an etree by another etree. Each etree is associated with a feature structure representing constraints on substitution and adjunction. Feature structures are combined using unification during the combination of etrees. We plan to integrate our toolkit for XTAG grammars into the Python-based Natural Language Toolkit (NLTK: nltk.org. We have provided an API capable of searching the lexicalized etrees for a given word or multiple words, searching for a etree by name or function, display the lexicalized etrees to the user using a graphical view, display the feature structure associated with each tree node in an etree, hide or highlight features based on a regular expression, and browsing the entire tree database for each XTAG grammar.

  8. Plant neighbor identity influences plant biochemistry and physiology related to defense.

    Science.gov (United States)

    Broz, Amanda K; Broeckling, Corey D; De-la-Peña, Clelia; Lewis, Matthew R; Greene, Erick; Callaway, Ragan M; Sumner, Lloyd W; Vivanco, Jorge M

    2010-06-17

    Chemical and biological processes dictate an individual organism's ability to recognize and respond to other organisms. A small but growing body of evidence suggests that plants may be capable of recognizing and responding to neighboring plants in a species specific fashion. Here we tested whether or not individuals of the invasive exotic weed, Centaurea maculosa, would modulate their defensive strategy in response to different plant neighbors. In the greenhouse, C. maculosa individuals were paired with either conspecific (C. maculosa) or heterospecific (Festuca idahoensis) plant neighbors and elicited with the plant defense signaling molecule methyl jasmonate to mimic insect herbivory. We found that elicited C. maculosa plants grown with conspecific neighbors exhibited increased levels of total phenolics, whereas those grown with heterospecific neighbors allocated more resources towards growth. To further investigate these results in the field, we conducted a metabolomics analysis to explore chemical differences between individuals of C. maculosa growing in naturally occurring conspecific and heterospecific field stands. Similar to the greenhouse results, C. maculosa individuals accumulated higher levels of defense-related secondary metabolites and lower levels of primary metabolites when growing in conspecific versus heterospecific field stands. Leaf herbivory was similar in both stand types; however, a separate field study positively correlated specialist herbivore load with higher densities of C. maculosa conspecifics. Our results suggest that an individual C. maculosa plant can change its defensive strategy based on the identity of its plant neighbors. This is likely to have important consequences for individual and community success.

  9. Study of international published experiences in joining copper and copper-alloys

    International Nuclear Information System (INIS)

    Dahlgren, Aa.

    1997-04-01

    This study has revealed a number of joining processes to be used when manufacturing copper-canisters for the final storage of high level nuclear waste. However, the decision on which material and which joining process to be used has to be based on the design criterions. The welding procedure has to be qualified, i.e. it shall be demonstrated whether the procedure is capable of fulfilling specified requirements. 32 refs

  10. Neighbor Discovery Algorithm in Wireless Local Area Networks Using Multi-beam Directional Antennas

    Science.gov (United States)

    Wang, Jin; Peng, Wei; Liu, Song

    2017-10-01

    Neighbor discovery is an important step for Wireless Local Area Networks (WLAN) and the use of multi-beam directional antennas can greatly improve the network performance. However, most neighbor discovery algorithms in WLAN, based on multi-beam directional antennas, can only work effectively in synchronous system but not in asynchro-nous system. And collisions at AP remain a bottleneck for neighbor discovery. In this paper, we propose two asynchrono-us neighbor discovery algorithms: asynchronous hierarchical scanning (AHS) and asynchronous directional scanning (ADS) algorithm. Both of them are based on three-way handshaking mechanism. AHS and ADS reduce collisions at AP to have a good performance in a hierarchical way and directional way respectively. In the end, the performance of the AHS and ADS are tested on OMNeT++. Moreover, it is analyzed that different application scenarios and the factors how to affect the performance of these algorithms. The simulation results show that AHS is suitable for the densely populated scenes around AP while ADS is suitable for that most of the neighborhood nodes are far from AP.

  11. Analysis of large fault trees based on functional decomposition

    International Nuclear Information System (INIS)

    Contini, Sergio; Matuzas, Vaidas

    2011-01-01

    With the advent of the Binary Decision Diagrams (BDD) approach in fault tree analysis, a significant enhancement has been achieved with respect to previous approaches, both in terms of efficiency and accuracy of the overall outcome of the analysis. However, the exponential increase of the number of nodes with the complexity of the fault tree may prevent the construction of the BDD. In these cases, the only way to complete the analysis is to reduce the complexity of the BDD by applying the truncation technique, which nevertheless implies the problem of estimating the truncation error or upper and lower bounds of the top-event unavailability. This paper describes a new method to analyze large coherent fault trees which can be advantageously applied when the working memory is not sufficient to construct the BDD. It is based on the decomposition of the fault tree into simpler disjoint fault trees containing a lower number of variables. The analysis of each simple fault tree is performed by using all the computational resources. The results from the analysis of all simpler fault trees are re-combined to obtain the results for the original fault tree. Two decomposition methods are herewith described: the first aims at determining the minimal cut sets (MCS) and the upper and lower bounds of the top-event unavailability; the second can be applied to determine the exact value of the top-event unavailability. Potentialities, limitations and possible variations of these methods will be discussed with reference to the results of their application to some complex fault trees.

  12. Analysis of large fault trees based on functional decomposition

    Energy Technology Data Exchange (ETDEWEB)

    Contini, Sergio, E-mail: sergio.contini@jrc.i [European Commission, Joint Research Centre, Institute for the Protection and Security of the Citizen, 21020 Ispra (Italy); Matuzas, Vaidas [European Commission, Joint Research Centre, Institute for the Protection and Security of the Citizen, 21020 Ispra (Italy)

    2011-03-15

    With the advent of the Binary Decision Diagrams (BDD) approach in fault tree analysis, a significant enhancement has been achieved with respect to previous approaches, both in terms of efficiency and accuracy of the overall outcome of the analysis. However, the exponential increase of the number of nodes with the complexity of the fault tree may prevent the construction of the BDD. In these cases, the only way to complete the analysis is to reduce the complexity of the BDD by applying the truncation technique, which nevertheless implies the problem of estimating the truncation error or upper and lower bounds of the top-event unavailability. This paper describes a new method to analyze large coherent fault trees which can be advantageously applied when the working memory is not sufficient to construct the BDD. It is based on the decomposition of the fault tree into simpler disjoint fault trees containing a lower number of variables. The analysis of each simple fault tree is performed by using all the computational resources. The results from the analysis of all simpler fault trees are re-combined to obtain the results for the original fault tree. Two decomposition methods are herewith described: the first aims at determining the minimal cut sets (MCS) and the upper and lower bounds of the top-event unavailability; the second can be applied to determine the exact value of the top-event unavailability. Potentialities, limitations and possible variations of these methods will be discussed with reference to the results of their application to some complex fault trees.

  13. Assessing hydrological impacts of tree-based bioenergy feedstock

    CSIR Research Space (South Africa)

    Gush, Mark B

    2010-01-01

    Full Text Available This chapter provides a methodology for assessing the hydrological impacts of tree-based bioenergy feedstock. Based on experience gained in South Africa, it discusses the tasks required to reach an understanding of the likely water resource impacts...

  14. IVisTMSA: Interactive Visual Tools for Multiple Sequence Alignments.

    Science.gov (United States)

    Pervez, Muhammad Tariq; Babar, Masroor Ellahi; Nadeem, Asif; Aslam, Naeem; Naveed, Nasir; Ahmad, Sarfraz; Muhammad, Shah; Qadri, Salman; Shahid, Muhammad; Hussain, Tanveer; Javed, Maryam

    2015-01-01

    IVisTMSA is a software package of seven graphical tools for multiple sequence alignments. MSApad is an editing and analysis tool. It can load 409% more data than Jalview, STRAP, CINEMA, and Base-by-Base. MSA comparator allows the user to visualize consistent and inconsistent regions of reference and test alignments of more than 21-MB size in less than 12 seconds. MSA comparator is 5,200% efficient and more than 40% efficient as compared to BALiBASE c program and FastSP, respectively. MSA reconstruction tool provides graphical user interfaces for four popular aligners and allows the user to load several sequence files at a time. FASTA generator converts seven formats of alignments of unlimited size into FASTA format in a few seconds. MSA ID calculator calculates identity matrix of more than 11,000 sequences with a sequence length of 2,696 base pairs in less than 100 seconds. Tree and Distance Matrix calculation tools generate phylogenetic tree and distance matrix, respectively, using neighbor joining% identity and BLOSUM 62 matrix.

  15. VMCast: A VM-Assisted Stability Enhancing Solution for Tree-Based Overlay Multicast.

    Directory of Open Access Journals (Sweden)

    Weidong Gu

    Full Text Available Tree-based overlay multicast is an effective group communication method for media streaming applications. However, a group member's departure causes all of its descendants to be disconnected from the multicast tree for some time, which results in poor performance. The above problem is difficult to be addressed because overlay multicast tree is intrinsically instable. In this paper, we proposed a novel stability enhancing solution, VMCast, for tree-based overlay multicast. This solution uses two types of on-demand cloud virtual machines (VMs, i.e., multicast VMs (MVMs and compensation VMs (CVMs. MVMs are used to disseminate the multicast data, whereas CVMs are used to offer streaming compensation. The used VMs in the same cloud datacenter constitute a VM cluster. Each VM cluster is responsible for a service domain (VMSD, and each group member belongs to a specific VMSD. The data source delivers the multicast data to MVMs through a reliable path, and MVMs further disseminate the data to group members along domain overlay multicast trees. The above approach structurally improves the stability of the overlay multicast tree. We further utilized CVM-based streaming compensation to enhance the stability of the data distribution in the VMSDs. VMCast can be used as an extension to existing tree-based overlay multicast solutions, to provide better services for media streaming applications. We applied VMCast to two application instances (i.e., HMTP and HCcast. The results show that it can obviously enhance the stability of the data distribution.

  16. Tungsten foil laminate for structural divertor applications - Joining of tungsten foils

    Science.gov (United States)

    Reiser, Jens; Rieth, Michael; Möslang, Anton; Dafferner, Bernhard; Hoffmann, Jan; Mrotzek, Tobias; Hoffmann, Andreas; Armstrong, D. E. J.; Yi, Xiaoou

    2013-05-01

    This paper is the fourth in our series on tungsten laminates. The aim of this paper is to discuss laminate synthesis, meaning the joining of tungsten foils. It is obvious that the properties of the tungsten laminate strongly depend on the combination of (i) interlayer and (ii) joining technology, as this combination defines (i) the condition of the tungsten foil after joining (as-received or recrystallised) as well as (ii) the characteristics of the interface between the tungsten foil and the interlayer (wettability or diffusion leading to a solid solution or the formation of intermetallics). From the example of tungsten laminates joined by brazing with (i) an eutectic silver copper brazing filler, (ii) copper, (iii) titanium, and (iv) zirconium, the microstructure will be discussed, with special focus on the interface. Based on our assumptions of the mechanism of the extraordinary ductility of tungsten foil we present three syntheses strategies and make recommendations for the synthesis of high temperature tungsten laminates.

  17. Multiple k Nearest Neighbor Query Processing in Spatial Network Databases

    DEFF Research Database (Denmark)

    Xuegang, Huang; Jensen, Christian Søndergaard; Saltenis, Simonas

    2006-01-01

    This paper concerns the efficient processing of multiple k nearest neighbor queries in a road-network setting. The assumed setting covers a range of scenarios such as the one where a large population of mobile service users that are constrained to a road network issue nearest-neighbor queries...... for points of interest that are accessible via the road network. Given multiple k nearest neighbor queries, the paper proposes progressive techniques that selectively cache query results in main memory and subsequently reuse these for query processing. The paper initially proposes techniques for the case...... where an upper bound on k is known a priori and then extends the techniques to the case where this is not so. Based on empirical studies with real-world data, the paper offers insight into the circumstances under which the different proposed techniques can be used with advantage for multiple k nearest...

  18. Development of a double beam process for joining aluminum and steel

    Science.gov (United States)

    Frank, Sascha

    2014-02-01

    Multi-material structures pose an attractive option for overcoming some of the central challenges in lightweight design. An exceptionally high potential for creating cost-effective lightweight solutions is attributed to the combination of steel and aluminum. However, these materials are also particularly difficult to join due to their tendency to form intermetallic compounds (IMCs). The growth of these compounds is facilitated by high temperatures and long process times. Due to their high brittleness, IMCs can severely weaken a joint. Thus, it is only possible to create durable steel-aluminum joints when the formation of IMCs can be limited to a non-critical level. To meet this goal, a new joining method has been designed. The method is based on the combination of a continuous wave (pw) and a pulsed laser (pw) source. Laser beams from both sources are superimposed in a common process zone. This makes it possible to apply the advantages of laser brazing to mixed-metal joints without requiring the use of chemical fluxes. The double beam technology was first tested in bead-on-plate experiments using different filler wire materials. Based on the results of these tests, a process for joining steel and aluminum in a double-flanged configuration is now being developed. The double flanged seams are joined using zinc- or aluminum-based filler wires. Microsections of selected seams show that it is possible to achieve good base material wetting while limiting the growth of IMCs to acceptable measures. In addition, the results of tensile tests show that high joint strengths can be achieved.

  19. Building Representative-Based Data Aggregation Tree in Wireless Sensor Networks

    Directory of Open Access Journals (Sweden)

    Yanfei Zheng

    2010-01-01

    Full Text Available Data aggregation is an essential operation to reduce energy consumption in large-scale wireless sensor networks (WSNs. A compromised node may forge an aggregation result and mislead base station into trusting a false reading. Efficient and secure aggregation scheme is critical in WSN applications due to the stringent resource constraints. In this paper, we propose a method to build up the representative-based aggregation tree in the WSNs such that the sensing data are aggregated along the route from the leaf cell to the root of the tree. In the cinema of large-scale and high-density sensor nodes, representative-based aggregation tree can reduce the data transmission overhead greatly by directed aggregation and cell-by-cell communications. It also provides security services including the integrity, freshness, and authentication, via detection mechanism in the cells.

  20. The Application of Determining Students’ Graduation Status of STMIK Palangkaraya Using K-Nearest Neighbors Method

    Science.gov (United States)

    Rusdiana, Lili; Marfuah

    2017-12-01

    K-Nearest Neighbors method is one of methods used for classification which calculate a value to find out the closest in distance. It is used to group a set of data such as students’ graduation status that are got from the amount of course credits taken by them, the grade point average (AVG), and the mini-thesis grade. The study is conducted to know the results of using K-Nearest Neighbors method on the application of determining students’ graduation status, so it can be analyzed from the method used, the data, and the application constructed. The aim of this study is to find out the application results by using K-Nearest Neighbors concept to determine students’ graduation status using the data of STMIK Palangkaraya students. The development of the software used Extreme Programming, since it was appropriate and precise for this study which was to quickly finish the project. The application was created using Microsoft Office Excel 2007 for the training data and Matlab 7 to implement the application. The result of K-Nearest Neighbors method on the application of determining students’ graduation status was 92.5%. It could determine the predicate graduation of 94 data used from the initial data before the processing as many as 136 data which the maximal training data was 50data. The K-Nearest Neighbors method is one of methods used to group a set of data based on the closest value, so that using K-Nearest Neighbors method agreed with this study. The results of K-Nearest Neighbors method on the application of determining students’ graduation status was 92.5% could determine the predicate graduation which is the maximal training data. The K-Nearest Neighbors method is one of methods used to group a set of data based on the closest value, so that using K-Nearest Neighbors method agreed with this study.

  1. Phylogenetic study of Theileria lestoquardi based on 18SrRNA gene Isolated from sheep in the middle region of Iraq

    Directory of Open Access Journals (Sweden)

    M.J.A. Alkhaled

    2016-12-01

    Full Text Available Theileriosis is parasitic infection causes by obligate intracellular protozoa of the genus Theileria. T. lestoquardi is the most virulent species in sheep and goats which causes a severe disease with a high morbidity and mortality rate. In this study the phylogenetic relationships between two local isolate of T. lestoquardi and nine T. lestoquardi global isolates as well as Babesia ovis out-group isolate were analyzed using the 18S rRNA gene sequence. The multiple sequence alignment analysis and neighbor joining phylogenetic tree analysis were performed by using ClustalW multiple sequence alignment online based analysis of 1098bp 18S rRNA gene was amplified by polymerase chain reaction. Phylogenetic analysis results of these gene sequences revealed that T. lestoquardi local isolates were closely related to T. lestoquardi Iran isolate (JQ917458.1 and two Iraq Kurdistan isolates (KC778786.1 and KC778785.1 more than other countries. This study represents the first report on the use of molecular phylogeny to classify T. lestoquardi obtained in Middle Region of Iraq.

  2. Multidimensional k-nearest neighbor model based on EEMD for financial time series forecasting

    Science.gov (United States)

    Zhang, Ningning; Lin, Aijing; Shang, Pengjian

    2017-07-01

    In this paper, we propose a new two-stage methodology that combines the ensemble empirical mode decomposition (EEMD) with multidimensional k-nearest neighbor model (MKNN) in order to forecast the closing price and high price of the stocks simultaneously. The modified algorithm of k-nearest neighbors (KNN) has an increasingly wide application in the prediction of all fields. Empirical mode decomposition (EMD) decomposes a nonlinear and non-stationary signal into a series of intrinsic mode functions (IMFs), however, it cannot reveal characteristic information of the signal with much accuracy as a result of mode mixing. So ensemble empirical mode decomposition (EEMD), an improved method of EMD, is presented to resolve the weaknesses of EMD by adding white noise to the original data. With EEMD, the components with true physical meaning can be extracted from the time series. Utilizing the advantage of EEMD and MKNN, the new proposed ensemble empirical mode decomposition combined with multidimensional k-nearest neighbor model (EEMD-MKNN) has high predictive precision for short-term forecasting. Moreover, we extend this methodology to the case of two-dimensions to forecast the closing price and high price of the four stocks (NAS, S&P500, DJI and STI stock indices) at the same time. The results indicate that the proposed EEMD-MKNN model has a higher forecast precision than EMD-KNN, KNN method and ARIMA.

  3. Plant neighbor identity influences plant biochemistry and physiology related to defense

    Directory of Open Access Journals (Sweden)

    Callaway Ragan M

    2010-06-01

    Full Text Available Abstract Background Chemical and biological processes dictate an individual organism's ability to recognize and respond to other organisms. A small but growing body of evidence suggests that plants may be capable of recognizing and responding to neighboring plants in a species specific fashion. Here we tested whether or not individuals of the invasive exotic weed, Centaurea maculosa, would modulate their defensive strategy in response to different plant neighbors. Results In the greenhouse, C. maculosa individuals were paired with either conspecific (C. maculosa or heterospecific (Festuca idahoensis plant neighbors and elicited with the plant defense signaling molecule methyl jasmonate to mimic insect herbivory. We found that elicited C. maculosa plants grown with conspecific neighbors exhibited increased levels of total phenolics, whereas those grown with heterospecific neighbors allocated more resources towards growth. To further investigate these results in the field, we conducted a metabolomics analysis to explore chemical differences between individuals of C. maculosa growing in naturally occurring conspecific and heterospecific field stands. Similar to the greenhouse results, C. maculosa individuals accumulated higher levels of defense-related secondary metabolites and lower levels of primary metabolites when growing in conspecific versus heterospecific field stands. Leaf herbivory was similar in both stand types; however, a separate field study positively correlated specialist herbivore load with higher densities of C. maculosa conspecifics. Conclusions Our results suggest that an individual C. maculosa plant can change its defensive strategy based on the identity of its plant neighbors. This is likely to have important consequences for individual and community success.

  4. Cophenetic metrics for phylogenetic trees, after Sokal and Rohlf.

    Science.gov (United States)

    Cardona, Gabriel; Mir, Arnau; Rosselló, Francesc; Rotger, Lucía; Sánchez, David

    2013-01-16

    Phylogenetic tree comparison metrics are an important tool in the study of evolution, and hence the definition of such metrics is an interesting problem in phylogenetics. In a paper in Taxon fifty years ago, Sokal and Rohlf proposed to measure quantitatively the difference between a pair of phylogenetic trees by first encoding them by means of their half-matrices of cophenetic values, and then comparing these matrices. This idea has been used several times since then to define dissimilarity measures between phylogenetic trees but, to our knowledge, no proper metric on weighted phylogenetic trees with nested taxa based on this idea has been formally defined and studied yet. Actually, the cophenetic values of pairs of different taxa alone are not enough to single out phylogenetic trees with weighted arcs or nested taxa. For every (rooted) phylogenetic tree T, let its cophenetic vectorφ(T) consist of all pairs of cophenetic values between pairs of taxa in T and all depths of taxa in T. It turns out that these cophenetic vectors single out weighted phylogenetic trees with nested taxa. We then define a family of cophenetic metrics dφ,p by comparing these cophenetic vectors by means of Lp norms, and we study, either analytically or numerically, some of their basic properties: neighbors, diameter, distribution, and their rank correlation with each other and with other metrics. The cophenetic metrics can be safely used on weighted phylogenetic trees with nested taxa and no restriction on degrees, and they can be computed in O(n2) time, where n stands for the number of taxa. The metrics dφ,1 and dφ,2 have positive skewed distributions, and they show a low rank correlation with the Robinson-Foulds metric and the nodal metrics, and a very high correlation with each other and with the splitted nodal metrics. The diameter of dφ,p, for p⩾1 , is in O(n(p+2)/p), and thus for low p they are more discriminative, having a wider range of values.

  5. A Regression-based K nearest neighbor algorithm for gene function prediction from heterogeneous data

    Directory of Open Access Journals (Sweden)

    Ruzzo Walter L

    2006-03-01

    Full Text Available Abstract Background As a variety of functional genomic and proteomic techniques become available, there is an increasing need for functional analysis methodologies that integrate heterogeneous data sources. Methods In this paper, we address this issue by proposing a general framework for gene function prediction based on the k-nearest-neighbor (KNN algorithm. The choice of KNN is motivated by its simplicity, flexibility to incorporate different data types and adaptability to irregular feature spaces. A weakness of traditional KNN methods, especially when handling heterogeneous data, is that performance is subject to the often ad hoc choice of similarity metric. To address this weakness, we apply regression methods to infer a similarity metric as a weighted combination of a set of base similarity measures, which helps to locate the neighbors that are most likely to be in the same class as the target gene. We also suggest a novel voting scheme to generate confidence scores that estimate the accuracy of predictions. The method gracefully extends to multi-way classification problems. Results We apply this technique to gene function prediction according to three well-known Escherichia coli classification schemes suggested by biologists, using information derived from microarray and genome sequencing data. We demonstrate that our algorithm dramatically outperforms the naive KNN methods and is competitive with support vector machine (SVM algorithms for integrating heterogenous data. We also show that by combining different data sources, prediction accuracy can improve significantly. Conclusion Our extension of KNN with automatic feature weighting, multi-class prediction, and probabilistic inference, enhance prediction accuracy significantly while remaining efficient, intuitive and flexible. This general framework can also be applied to similar classification problems involving heterogeneous datasets.

  6. Screening of tomato varieties for fruit tree based Agroforestry system

    Directory of Open Access Journals (Sweden)

    J. Hossain

    2014-12-01

    Full Text Available An experiment was conducted with four tomato varieties under a six year old orchard was accomplished at the Bangabandhu Sheikh Mujibur Rahman Agricultural University (BSMRAU research farm during October 2011 to April 2012. The experiment was laid out in a Randomized Complete Block Design with three replications. Four tomato varieties (BARI Tomato 2, BARI Tomato 8, BARI Tomato 14 and BARI Tomato 15 were grown under guava, mango, olive and control. Results showed that light availability in control plot (999.75 μ mol m-2s-1 was remarkably higher over fruit tree based agroforestry systems and it was 58.8, 43.9 and 31.5% of the control for guava, mango and olive based systems, respectively. The shortest tomato plant was observed in olive based system (54.91 cm, while the tallest plant was observed in mango based system (60.09 cm. The highest SPAD value and number of primary branches per plant was recorded in control plot. Fruit length, fruit girth was found lowest in olive based system. The highest yield (34.06 t ha-1 was recorded in control plot while the lowest yield (10.26 t ha-1 was recorded in olive based system. The economic performance of fruit tree based tomato production system showed that both the net return and BCR of mango and guava based system was higher over control and olive based system. The contents of organic carbon, nitrogen, available phosphorus, potassium and sulfur of before experimentation soil were slightly higher in fruit tree based agroforestry systems than the control. After experimentation, nutrient elements in soil were found increased slightly than initial soils. Fruit tree based agroforestry systems could be ranked based on the economic performance as mango> guava> control> olive based system with BARI Tomato 15, BARI Tomato 2, BARI Tomato 14 and BARI Tomato 8, respectively.

  7. Multicasting in Wireless Communications (Ad-Hoc Networks): Comparison against a Tree-Based Approach

    Science.gov (United States)

    Rizos, G. E.; Vasiliadis, D. C.

    2007-12-01

    We examine on-demand multicasting in ad hoc networks. The Core Assisted Mesh Protocol (CAMP) is a well-known protocol for multicast routing in ad-hoc networks, generalizing the notion of core-based trees employed for internet multicasting into multicast meshes that have much richer connectivity than trees. On the other hand, wireless tree-based multicast routing protocols use much simpler structures for determining route paths, using only parent-child relationships. In this work, we compare the performance of the CAMP protocol against the performance of wireless tree-based multicast routing protocols, in terms of two important factors, namely packet delay and ratio of dropped packets.

  8. Radiofrequency radiation injures trees around mobile phone base stations.

    Science.gov (United States)

    Waldmann-Selsam, Cornelia; Balmori-de la Puente, Alfonso; Breunig, Helmut; Balmori, Alfonso

    2016-12-01

    In the last two decades, the deployment of phone masts around the world has taken place and, for many years, there has been a discussion in the scientific community about the possible environmental impact from mobile phone base stations. Trees have several advantages over animals as experimental subjects and the aim of this study was to verify whether there is a connection between unusual (generally unilateral) tree damage and radiofrequency exposure. To achieve this, a detailed long-term (2006-2015) field monitoring study was performed in the cities of Bamberg and Hallstadt (Germany). During monitoring, observations and photographic recordings of unusual or unexplainable tree damage were taken, alongside the measurement of electromagnetic radiation. In 2015 measurements of RF-EMF (Radiofrequency Electromagnetic Fields) were carried out. A polygon spanning both cities was chosen as the study site, where 144 measurements of the radiofrequency of electromagnetic fields were taken at a height of 1.5m in streets and parks at different locations. By interpolation of the 144 measurement points, we were able to compile an electromagnetic map of the power flux density in Bamberg and Hallstadt. We selected 60 damaged trees, in addition to 30 randomly selected trees and 30 trees in low radiation areas (n=120) in this polygon. The measurements of all trees revealed significant differences between the damaged side facing a phone mast and the opposite side, as well as differences between the exposed side of damaged trees and all other groups of trees in both sides. Thus, we found that side differences in measured values of power flux density corresponded to side differences in damage. The 30 selected trees in low radiation areas (no visual contact to any phone mast and power flux density under 50μW/m 2 ) showed no damage. Statistical analysis demonstrated that electromagnetic radiation from mobile phone masts is harmful for trees. These results are consistent with the fact

  9. Spatio-temporal joins on symbolic indoor tracking data

    DEFF Research Database (Denmark)

    Lu, Hua; Yang, Bin; Jensen, Christian S.

    2011-01-01

    and studies probabilistic, spatio-temporal joins on historical indoor tracking data. Two meaningful types of join are defined. They return object pairs that satisfy spatial join predicates either at a time point or during a time interval. The predicates considered include “same X,” where X is a semantic...

  10. Comparative analysis of the practice of China and Russia joining the WTO

    Directory of Open Access Journals (Sweden)

    Anastasia Sergeyevna Loginova

    2015-09-01

    Full Text Available Objective to examine the positive and negative experience of China39s joining the World Trade Organization WTO that joined it on terms similar to the Russian ones for the best understanding of the advantages and disadvantages of joining and building the appropriate policy. Methods the objective of the work has been achieved through the application of both general and specific scientific methods. In particular the analysis and synthesis allowed to study the social and economic context of the state in the framework of joining the WTO the consequences of such membership and to identify the key areas for improvement of this step for Russia. Statistical techniques were used in the process of gathering information about the key economic indicators. The fundamental method was comparativelegal which made it possible to draw parallels in joining the WTO by various states. Results basing on the measures taken by China both before and after joining the WTO as well as evaluation of their implication the conclusion was made about its successful experience. The actions before joining were very effective. In particular they are applicable to the fields of agriculture automotive industry investment policy etc. The measures of nonaddress subsidizing maintaining the socioeconomic stability in the country the export orientation of the economy along with functioning of special economic zones with joint ventures are in the authors39 opinion constructive actions for Russiarsquos adaptation to the WTO. Scientific novelty for the first time the thesis is put forward about the similarity of the Russia and China conditions when joining the WTO. The analysis is made of the complex measures preceding and following the joining. The necessity is grounded of reflecting the China39s positive and negative experiences in the Russian policy. Practical significance the main provisions and conclusions can be used in the research activity in addressing the issues of Russiarsquos

  11. Boolean Operations, Joins, and the Extended Low Hierarchy

    OpenAIRE

    Hemaspaandra, Lane A.; Jiang, Zhigen; Rothe, Joerg; Watanabe, Osamu

    1999-01-01

    We prove that the join of two sets may actually fall into a lower level of the extended low hierarchy than either of the sets. In particular, there exist sets that are not in the second level of the extended low hierarchy, EL_2, yet their join is in EL_2. That is, in terms of extended lowness, the join operator can lower complexity. Since in a strong intuitive sense the join does not lower complexity, our result suggests that the extended low hierarchy is unnatural as a complexity measure. We...

  12. Performance of electro-plated and joined components for divertor application

    International Nuclear Information System (INIS)

    Krauss, Wolfgang; Lorenz, Julia; Konys, Jürgen

    2013-01-01

    Highlights: • Active interlayers of Ni and Pd were electroplated on W to assist joining. • Demonstrator types of W-steel and W–W joints were successfully fabricated. • Diffusion processes increase operation temperature above brazing temperature. • Ni electro-plating is less sensitive to variation of deposition parameters than Pd. • Shear tests showed values in resistance comparable to those of commercial fillers. -- Abstract: A general challenge in divertor development, independently of design type and cooling medium water or helium, is the reliable and adapted joining of components. Depending on the design variants, the characteristics of the joints will be focused on functional or structural behavior to guarantee e.g. good thermal conductivity and sufficient mechanical strength. All variants will have in common that tungsten is the plasma facing material. Thus, material combinations to be joined will range from Cu base over steel to tungsten. Especially tungsten shows lacks in adapted joining due to its metallurgical behavior ranging from immiscibility over bad wetting up to brittle intermetallic phase formation. Joining assisted by electro-chemical deposition of functional and filler layers showed that encouraging progress was achieved in wetting applying nickel interlayers. Nickel proved to be a good reference material but alternative elements (e.g. Pd, Fe) may be more attractive in fusion to manufacture suitable joints. Replacing of Ni as activator element by Pd for W/W or W/steel joints was achieved and joining with Cu-filler was successfully performed. Manufactured joints were characterized applying metallurgical testing and SEM/EDX analyses demonstrating the applicability of Pd activator. First shear tests showed that the joints exhibit mechanical stability sufficient for technical application

  13. Combustion Joining for Composite Fabrication

    Science.gov (United States)

    2009-10-25

    Inert preheating Process beginning T e m p e r a t u r e , o C Time, s I = 600 Amps D = 10 mm Joule preheating only up to Tig UNCLASSIFIED • C...Honeywell Corp (South Bend, IN) • Currently build aircraft brake disks from carbon fibers • use a long (~ 100 day) CVD process to densify • Brake wear...oxidation with every landing A380 -rejected take off test C-C brakes UNCLASSIFIED Joining C-Based Materials • Difficult task – Carbon cannot be welded

  14. Assessing the predictive capability of randomized tree-based ensembles in streamflow modelling

    Science.gov (United States)

    Galelli, S.; Castelletti, A.

    2013-07-01

    Combining randomization methods with ensemble prediction is emerging as an effective option to balance accuracy and computational efficiency in data-driven modelling. In this paper, we investigate the prediction capability of extremely randomized trees (Extra-Trees), in terms of accuracy, explanation ability and computational efficiency, in a streamflow modelling exercise. Extra-Trees are a totally randomized tree-based ensemble method that (i) alleviates the poor generalisation property and tendency to overfitting of traditional standalone decision trees (e.g. CART); (ii) is computationally efficient; and, (iii) allows to infer the relative importance of the input variables, which might help in the ex-post physical interpretation of the model. The Extra-Trees potential is analysed on two real-world case studies - Marina catchment (Singapore) and Canning River (Western Australia) - representing two different morphoclimatic contexts. The evaluation is performed against other tree-based methods (CART and M5) and parametric data-driven approaches (ANNs and multiple linear regression). Results show that Extra-Trees perform comparatively well to the best of the benchmarks (i.e. M5) in both the watersheds, while outperforming the other approaches in terms of computational requirement when adopted on large datasets. In addition, the ranking of the input variable provided can be given a physically meaningful interpretation.

  15. Joining elements of silicon carbide

    International Nuclear Information System (INIS)

    Olson, B.A.

    1979-01-01

    A method of joining together at least two silicon carbide elements (e.g.in forming a heat exchanger) is described, comprising subjecting to sufficiently non-oxidizing atmosphere and sufficiently high temperature, material placed in space between the elements. The material consists of silicon carbide particles, carbon and/or a precursor of carbon, and silicon, such that it forms a joint joining together at least two silicon carbide elements. At least one of the elements may contain silicon. (author)

  16. Lidar-based individual tree species classification using convolutional neural network

    Science.gov (United States)

    Mizoguchi, Tomohiro; Ishii, Akira; Nakamura, Hiroyuki; Inoue, Tsuyoshi; Takamatsu, Hisashi

    2017-06-01

    Terrestrial lidar is commonly used for detailed documentation in the field of forest inventory investigation. Recent improvements of point cloud processing techniques enabled efficient and precise computation of an individual tree shape parameters, such as breast-height diameter, height, and volume. However, tree species are manually specified by skilled workers to date. Previous works for automatic tree species classification mainly focused on aerial or satellite images, and few works have been reported for classification techniques using ground-based sensor data. Several candidate sensors can be considered for classification, such as RGB or multi/hyper spectral cameras. Above all candidates, we use terrestrial lidar because it can obtain high resolution point cloud in the dark forest. We selected bark texture for the classification criteria, since they clearly represent unique characteristics of each tree and do not change their appearance under seasonable variation and aged deterioration. In this paper, we propose a new method for automatic individual tree species classification based on terrestrial lidar using Convolutional Neural Network (CNN). The key component is the creation step of a depth image which well describe the characteristics of each species from a point cloud. We focus on Japanese cedar and cypress which cover the large part of domestic forest. Our experimental results demonstrate the effectiveness of our proposed method.

  17. Estimating Uncertainty of Point-Cloud Based Single-Tree Segmentation with Ensemble Based Filtering

    Directory of Open Access Journals (Sweden)

    Matthew Parkan

    2018-02-01

    Full Text Available Individual tree crown segmentation from Airborne Laser Scanning data is a nodal problem in forest remote sensing. Focusing on single layered spruce and fir dominated coniferous forests, this article addresses the problem of directly estimating 3D segment shape uncertainty (i.e., without field/reference surveys, using a probabilistic approach. First, a coarse segmentation (marker controlled watershed is applied. Then, the 3D alpha hull and several descriptors are computed for each segment. Based on these descriptors, the alpha hulls are grouped to form ensembles (i.e., groups of similar tree shapes. By examining how frequently regions of a shape occur within an ensemble, it is possible to assign a shape probability to each point within a segment. The shape probability can subsequently be thresholded to obtain improved (filtered tree segments. Results indicate this approach can be used to produce segmentation reliability maps. A comparison to manually segmented tree crowns also indicates that the approach is able to produce more reliable tree shapes than the initial (unfiltered segmentation.

  18. Prediction of operon-like gene clusters in the Arabidopsis thaliana genome based on co-expression analysis of neighboring genes.

    Science.gov (United States)

    Wada, Masayoshi; Takahashi, Hiroki; Altaf-Ul-Amin, Md; Nakamura, Kensuke; Hirai, Masami Y; Ohta, Daisaku; Kanaya, Shigehiko

    2012-07-15

    Operon-like arrangements of genes occur in eukaryotes ranging from yeasts and filamentous fungi to nematodes, plants, and mammals. In plants, several examples of operon-like gene clusters involved in metabolic pathways have recently been characterized, e.g. the cyclic hydroxamic acid pathways in maize, the avenacin biosynthesis gene clusters in oat, the thalianol pathway in Arabidopsis thaliana, and the diterpenoid momilactone cluster in rice. Such operon-like gene clusters are defined by their co-regulation or neighboring positions within immediate vicinity of chromosomal regions. A comprehensive analysis of the expression of neighboring genes therefore accounts a crucial step to reveal the complete set of operon-like gene clusters within a genome. Genome-wide prediction of operon-like gene clusters should contribute to functional annotation efforts and provide novel insight into evolutionary aspects acquiring certain biological functions as well. We predicted co-expressed gene clusters by comparing the Pearson correlation coefficient of neighboring genes and randomly selected gene pairs, based on a statistical method that takes false discovery rate (FDR) into consideration for 1469 microarray gene expression datasets of A. thaliana. We estimated that A. thaliana contains 100 operon-like gene clusters in total. We predicted 34 statistically significant gene clusters consisting of 3 to 22 genes each, based on a stringent FDR threshold of 0.1. Functional relationships among genes in individual clusters were estimated by sequence similarity and functional annotation of genes. Duplicated gene pairs (determined based on BLAST with a cutoff of EOperon-like clusters tend to include genes encoding bio-machinery associated with ribosomes, the ubiquitin/proteasome system, secondary metabolic pathways, lipid and fatty-acid metabolism, and the lipid transfer system. Copyright © 2012 Elsevier B.V. All rights reserved.

  19. Protein function prediction using neighbor relativity in protein-protein interaction network.

    Science.gov (United States)

    Moosavi, Sobhan; Rahgozar, Masoud; Rahimi, Amir

    2013-04-01

    There is a large gap between the number of discovered proteins and the number of functionally annotated ones. Due to the high cost of determining protein function by wet-lab research, function prediction has become a major task for computational biology and bioinformatics. Some researches utilize the proteins interaction information to predict function for un-annotated proteins. In this paper, we propose a novel approach called "Neighbor Relativity Coefficient" (NRC) based on interaction network topology which estimates the functional similarity between two proteins. NRC is calculated for each pair of proteins based on their graph-based features including distance, common neighbors and the number of paths between them. In order to ascribe function to an un-annotated protein, NRC estimates a weight for each neighbor to transfer its annotation to the unknown protein. Finally, the unknown protein will be annotated by the top score transferred functions. We also investigate the effect of using different coefficients for various types of functions. The proposed method has been evaluated on Saccharomyces cerevisiae and Homo sapiens interaction networks. The performance analysis demonstrates that NRC yields better results in comparison with previous protein function prediction approaches that utilize interaction network. Copyright © 2012 Elsevier Ltd. All rights reserved.

  20. Joining and Performance of Alkali Metal Thermal-to-electric Converter (AMTEC)

    Energy Technology Data Exchange (ETDEWEB)

    Suh, Min-Soo; Lee, Wook-Hyun; Woo, Sang-Kuk [Korea Institute of Energy Research, Daejeon (Korea, Republic of)

    2017-07-15

    The alkali-Metal Thermal-to-electric Converter (AMTEC) is one of the promising static energy conversion technologies for the direct conversion of thermal energy to electrical energy. The advantages over a conventional energy converter are its high theoretical conversion efficiency of 40% and power density of 500 W/kg. The working principle of an AMTEC battery is the electrochemical reaction of the sodium through an ion conducting electrolyte. Sodium ion pass through the hot side of the beta”-alumina solid electrolyte (BASE) primarily as a result of the pressure difference. This pressure difference across the BASE has a significant effect on the overall performance of the AMTEC system. In order to build the high pressure difference across the BASE, hermeticity is required for each joined components for high temperature range of 900°C. The AMTEC battery was manufactured by utilizing robust joining technology of BASE/insulator/metal flange interfaces of the system for both structural and electrical stability. The electrical potential difference between the anode and cathode sides, where the electrons emitted from sodium ionization and recombined into sodium, was characterized as the open-circuit voltage. The efforts of technological improvement were concentrated on a high-power output and conversion efficiency. This paper discusses about the joining and performance of the AMTEC systems.

  1. Effect of electrode design on crosstalk between neighboring organic field-effect transistors based on one single crystal

    Science.gov (United States)

    Li, Mengjie; Tang, Qingxin; Tong, Yanhong; Zhao, Xiaoli; Zhou, Shujun; Liu, Yichun

    2018-03-01

    The design of high-integration organic circuits must be such that the interference between neighboring devices is eliminated. Here, rubrene crystals were used to study the effect of the electrode design on crosstalk between neighboring organic field-effect transistors (OFETs). Results show that a decreased source/drain interval and gate electrode width can decrease the diffraction distance of the current, and therefore can weaken the crosstalk. In addition, the inherent low carrier concentration in organic semiconductors can create a high-resistance barrier at the space between gate electrodes of neighboring devices, limiting or even eliminating the crosstalk as a result of the gate electrode width being smaller than the source/drain electrode width.

  2. Join or be excluded from biomedicine? JOINS and Post-colonial Korea.

    Science.gov (United States)

    Ma, Eunjeong

    2015-04-01

    This paper discusses re-emergence of Korean medicine(s) in the global context with a focus on a natural drug JOINS, a highly contentious drug regarding its legal status. By following through its life world, the paper contends that the drug is the embodiment of the postcolonial anxiety that crosses the intersections between the aspiring nation and globalizing strategies of the bio-pharmaceutical industry. JOINS is a natural drug prescribed to alleviate the symptoms of degenerative arthritis. SK Chemicals, Ltd., a giant domestic pharmaceutical company developed the drug by utilizing the knowledge of traditional pharmacopeia and put it on the market in 2001. In the domestic market, the drug is treated as a prescription drug, implying that Western medicine-trained doctors (as opposed to Korean medicine doctors) are entitled to prescribe drugs. It also indicates that the drug has undergone a series of lab tests such as toxicity, efficacy, and clinical trials in compliance with regulatory guidelines. However, the domestic standards are not rigorous enough to satisfy international standards, so that it is exported as a nutritional supplement abroad. The government, the pharmaceutical industry, and the Western medicine profession are happy with how the drug stands domestically and internationally. Rather, it is Korean doctors who try to disrupt the status quo and reclaim their rights to traditional knowledge, who have been alienated from the pharmaceuticalization of traditional knowledge. Thus, the JOINS tablet embodies the complex web of modern Korean society, professional interests, the pharmaceutical industry, and globalization.

  3. Molecular phylogeny of the neritidae (Gastropoda: Neritimorpha) based on the mitochondrial genes cytochrome oxidase I (COI) and 16S rRNA

    International Nuclear Information System (INIS)

    Quintero Galvis, Julian Fernando; Castro, Lyda Raquel

    2013-01-01

    The family Neritidae has representatives in tropical and subtropical regions that occur in a variety of environments, and its known fossil record dates back to the late Cretaceous. However there have been few studies of molecular phylogeny in this family. We performed a phylogenetic reconstruction of the family Neritidae using the COI (722 bp) and the 16S rRNA (559 bp) regions of the mitochondrial genome. Neighbor-joining, maximum parsimony and Bayesian inference were performed. The best phylogenetic reconstruction was obtained using the COI region, and we consider it an appropriate marker for phylogenetic studies within the group. Consensus analysis (COI +16S rRNA) generally obtained the same tree topologies and confirmed that the genus Nerita is monophyletic. The consensus analysis using parsimony recovered a monophyletic group consisting of the genera Neritina, Septaria, Theodoxus, Puperita, and Clithon, while in the Bayesian analyses Theodoxus is separated from the other genera. The phylogenetic status of the species from the genus Nerita from the Colombian Caribbean generated in this study was consistent with that reported for the genus in previous studies. In the resulting consensus tree obtained using maximum parsimony, we included information on habitat type for each species, to map the evolution by habitat. Species of the family Neritidae possibly have their origin in marine environments, which is consistent with conclusions from previous reports based on anatomical studies.

  4. Investigation of Thermoelectric Parameters of Bi2Te3: TEGs Assembled using Pressure-Assisted Silver Powder Sintering-Based Joining Technology

    Science.gov (United States)

    Stranz, Andrej; Waag, Andreas; Peiner, Erwin

    2015-06-01

    Operation of thermoelectric generator (TEG) modules based on bismuth telluride alloys at temperatures higher than 250°C is mostly limited by the melting point of the assembly solder. Although the thermoelectric parameters of bismuth telluride materials degrade for temperatures >130°C, the power output of the module can be enhanced with an increase in the temperature difference. For this, a temperature-stable joining technique, especially for the hot side of the modules, is required. Fabrication and process parameters of TEG modules consisting of bismuth telluride legs, alumina ceramics and copper interconnects using a joining technique based on pressure-assisted silver powder sintering are described. Measurements of the thermal force, electrical resistance, and output power are presented that were performed for hot side module temperatures up to 350°C and temperature differences higher than 300°C. Temperature cycling and results measured during extended high-temperature operation are addressed.

  5. Decision tree and PCA-based fault diagnosis of rotating machinery

    Science.gov (United States)

    Sun, Weixiang; Chen, Jin; Li, Jiaqing

    2007-04-01

    After analysing the flaws of conventional fault diagnosis methods, data mining technology is introduced to fault diagnosis field, and a new method based on C4.5 decision tree and principal component analysis (PCA) is proposed. In this method, PCA is used to reduce features after data collection, preprocessing and feature extraction. Then, C4.5 is trained by using the samples to generate a decision tree model with diagnosis knowledge. At last the tree model is used to make diagnosis analysis. To validate the method proposed, six kinds of running states (normal or without any defect, unbalance, rotor radial rub, oil whirl, shaft crack and a simultaneous state of unbalance and radial rub), are simulated on Bently Rotor Kit RK4 to test C4.5 and PCA-based method and back-propagation neural network (BPNN). The result shows that C4.5 and PCA-based diagnosis method has higher accuracy and needs less training time than BPNN.

  6. [Genome-wide identification, phylogenetic analysis and expression profiling of the WOX family genes in Solanum lycopersicum].

    Science.gov (United States)

    Li, Xiao-xu; Liu, Cheng; Li, Wei; Zhang, Zeng-lin; Gao, Xiao-ming; Zhou, Hui; Guo, Yong-feng

    2016-05-01

    Members of the plant-specific WOX transcription factor family have been reported to play important roles in cell to cell communication as well as other physiological and developmental processes. In this study, ten members of the WOX transcription factor family were identified in Solanum lycopersicum with HMMER. Neighbor-joining phylogenetic tree, maximum-likelihood tree and Bayesian-inference tree were constructed and similar topologies were shown using the protein sequences of the homeodomain. Phylogenetic study revealed that the 25 WOX family members from Arabidopsis and tomato fall into three clades and nine subfamilies. The patterns of exon-intron structures and organization of conserved domains in Arabidopsis and tomato were consistent based on the phylogenetic results. Transcriptome analysis showed that the expression patterns of SlWOXs were different in different tissue types. Gene Ontology (GO) analysis suggested that, as transcription factors, the SlWOX family members could be involved in a number of biological processes including cell to cell communication and tissue development. Our results are useful for future studies on WOX family members in tomato and other plant species.

  7. Comparing Individual Tree Segmentation Based on High Resolution Multispectral Image and Lidar Data

    Science.gov (United States)

    Xiao, P.; Kelly, M.; Guo, Q.

    2014-12-01

    This study compares the use of high-resolution multispectral WorldView images and high density Lidar data for individual tree segmentation. The application focuses on coniferous and deciduous forests in the Sierra Nevada Mountains. The tree objects are obtained in two ways: a hybrid region-merging segmentation method with multispectral images, and a top-down and bottom-up region-growing method with Lidar data. The hybrid region-merging method is used to segment individual tree from multispectral images. It integrates the advantages of global-oriented and local-oriented region-merging strategies into a unified framework. The globally most-similar pair of regions is used to determine the starting point of a growing region. The merging iterations are constrained within the local vicinity, thus the segmentation is accelerated and can reflect the local context. The top-down region-growing method is adopted in coniferous forest to delineate individual tree from Lidar data. It exploits the spacing between the tops of trees to identify and group points into a single tree based on simple rules of proximity and likely tree shape. The bottom-up region-growing method based on the intensity and 3D structure of Lidar data is applied in deciduous forest. It segments tree trunks based on the intensity and topological relationships of the points, and then allocate other points to exact tree crowns according to distance. The accuracies for each method are evaluated with field survey data in several test sites, covering dense and sparse canopy. Three types of segmentation results are produced: true positive represents a correctly segmented individual tree, false negative represents a tree that is not detected and assigned to a nearby tree, and false positive represents that a point or pixel cluster is segmented as a tree that does not in fact exist. They respectively represent correct-, under-, and over-segmentation. Three types of index are compared for segmenting individual tree

  8. Consequences of Common Topological Rearrangements for Partition Trees in Phylogenomic Inference.

    Science.gov (United States)

    Chernomor, Olga; Minh, Bui Quang; von Haeseler, Arndt

    2015-12-01

    In phylogenomic analysis the collection of trees with identical score (maximum likelihood or parsimony score) may hamper tree search algorithms. Such collections are coined phylogenetic terraces. For sparse supermatrices with a lot of missing data, the number of terraces and the number of trees on the terraces can be very large. If terraces are not taken into account, a lot of computation time might be unnecessarily spent to evaluate many trees that in fact have identical score. To save computation time during the tree search, it is worthwhile to quickly identify such cases. The score of a species tree is the sum of scores for all the so-called induced partition trees. Therefore, if the topological rearrangement applied to a species tree does not change the induced partition trees, the score of these partition trees is unchanged. Here, we provide the conditions under which the three most widely used topological rearrangements (nearest neighbor interchange, subtree pruning and regrafting, and tree bisection and reconnection) change the topologies of induced partition trees. During the tree search, these conditions allow us to quickly identify whether we can save computation time on the evaluation of newly encountered trees. We also introduce the concept of partial terraces and demonstrate that they occur more frequently than the original "full" terrace. Hence, partial terrace is the more important factor of timesaving compared to full terrace. Therefore, taking into account the above conditions and the partial terrace concept will help to speed up the tree search in phylogenomic inference.

  9. Species-Level Differences in Hyperspectral Metrics among Tropical Rainforest Trees as Determined by a Tree-Based Classifier

    Directory of Open Access Journals (Sweden)

    Dar A. Roberts

    2012-06-01

    Full Text Available This study explores a method to classify seven tropical rainforest tree species from full-range (400–2,500 nm hyperspectral data acquired at tissue (leaf and bark, pixel and crown scales using laboratory and airborne sensors. Metrics that respond to vegetation chemistry and structure were derived using narrowband indices, derivative- and absorption-based techniques, and spectral mixture analysis. We then used the Random Forests tree-based classifier to discriminate species with minimally-correlated, importance-ranked metrics. At all scales, best overall accuracies were achieved with metrics derived from all four techniques and that targeted chemical and structural properties across the visible to shortwave infrared spectrum (400–2500 nm. For tissue spectra, overall accuracies were 86.8% for leaves, 74.2% for bark, and 84.9% for leaves plus bark. Variation in tissue metrics was best explained by an axis of red absorption related to photosynthetic leaves and an axis distinguishing bark water and other chemical absorption features. Overall accuracies for individual tree crowns were 71.5% for pixel spectra, 70.6% crown-mean spectra, and 87.4% for a pixel-majority technique. At pixel and crown scales, tree structure and phenology at the time of image acquisition were important factors that determined species spectral separability.

  10. Sistem Rekomendasi Pada E-Commerce Menggunakan K-Nearest Neighbor

    Directory of Open Access Journals (Sweden)

    Chandra Saha Dewa Prasetya

    2017-09-01

    The growing number of product information available on the internet brings challenges to both customer and online businesses in the e-commerce environment. Customer often have difficulty when looking for products on the internet because of the number of products sold on the internet. In addition, online businessman often experience difficulties because they has much data about products, customers and transactions, thus causing online businessman have difficulty to promote the right product to a particular customer target. A recommendation system was developed to address those problem with various methods such as Collaborative Filtering, ContentBased, and Hybrid. Collaborative filtering method uses customer’s rating data, content based using product content such as title or description, and hybrid using both as the basis of the recommendation. In this research, the k-nearest neighbor algorithm is used to determine the top-n product recommendations for each buyer. The result of this research method Content Based outperforms other methods because the sparse data, that is the condition where the number of rating given by the customers is relatively little compared the number of products available in e-commerce. Keywords: recomendation system, k-nearest neighbor, collaborative filtering, content based.

  11. Joining of silicon carbide using interlayer with matching coefficient of thermal expansion

    International Nuclear Information System (INIS)

    Perham, T.

    1996-11-01

    The primary objective of this study is to develop a technique for joining a commercially available Silicon Carbide that gives good room temperature strength and the potential for good high temperature strength. One secondary objective is that the joining technique be adaptable to SiC f /SiC composites and/or Nickel based superalloys, and another secondary objective is that the materials provide good neutron irradiation resistance and low activation for potential application inside nuclear fusion reactors. The joining techniques studied here are: (1) reaction bonding with Al-Si/Si/SiC/C; (2) reaction/infiltration with calcium aluminum silicate; (3) ion exchange mechanism to form calcium hexaluminate (a refractory cement); and (4) oxide frit brazing with cordierite

  12. Calculation of force and time of contact formation at diffusion metal joining

    Energy Technology Data Exchange (ETDEWEB)

    Sukhanov, V E [Tsentral' nyj Nauchno-Issledovatel' skij Inst. Chernoj Metallurgii, Moscow (USSR); Grushevskij, A V [Moskovskij Stankoinstrumental' nyj Inst., Moscow (USSR); Surovtsev, A P

    1989-03-01

    An analytical model of contact for mation at diffusion joining is suggested. It is based on the introduction of a rough surface with roughnesses in the form of absolutely rigid spherical segnunts into a smooth laminar body. Mathematical expressions, permitting to calculate maximum welding force (pressure) providing close contact of the surfaces welded and time for contact formation between rough surfaces joined, are obtained. Divergence of calculational and experimental data does not exceed 20%. It is confirmed that the most intensive formation of joining occurs in the initial period of welding -the stage of formation of a physical contact, when deformation processes proceed in tensively. Finite formation of a strength joint occurs at the stage of diffusion interaction.

  13. Teens join the MoEDAL collaboration

    CERN Multimedia

    Stephanie Hills

    2013-01-01

    The principal investigator for any institute joining an experimental collaboration is generally a self-assured researcher with evident leadership skills and an in-depth knowledge of their subject gained over many years. Katherine Evans fits the brief in every respect, except that she is 17 years old and her research institute is the Langton Star Centre, based at the Simon Langton Grammar School for Boys. The school has just joined the MoEDAL experiment.   Teacher Becky Parker (left) with two students from the Simon Langton Grammar School for Boys in the MoEDAL experimental area. MoEDAL, the latest LHC experiment has detectors located close to the interaction point of the LHCb experiment. This new experiment is designed to search for the highly ionizing avatars of new physics at the LHC, specifically the magnetic monopole or dyon and other highly ionizing stable massive particles from a number of beyond-the-Standard-Model scenarios. MoEDAL was approved in 2010 and is due to start taking data i...

  14. Numerical modelling in friction lap joining of aluminium alloy and carbon-fiber-reinforced-plastic sheets

    Science.gov (United States)

    Das, A.; Bang, H. S.; Bang, H. S.

    2018-05-01

    Multi-material combinations of aluminium alloy and carbon-fiber-reinforced-plastics (CFRP) have gained attention in automotive and aerospace industries to enhance fuel efficiency and strength-to-weight ratio of components. Various limitations of laser beam welding, adhesive bonding and mechanical fasteners make these processes inefficient to join metal and CFRP sheets. Friction lap joining is an alternative choice for the same. Comprehensive studies in friction lap joining of aluminium to CFRP sheets are essential and scare in the literature. The present work reports a combined theoretical and experimental study in joining of AA5052 and CFRP sheets using friction lap joining process. A three-dimensional finite element based heat transfer model is developed to compute the temperature fields and thermal cycles. The computed results are validated extensively with the corresponding experimentally measured results.

  15. Tungsten foil laminate for structural divertor applications – Joining of tungsten foils

    Energy Technology Data Exchange (ETDEWEB)

    Reiser, Jens, E-mail: jens.reiser@kit.edu [Karlsruhe Institute of Technology (KIT), Institute for Applied Materials (IAM-AWP) (Germany); Rieth, Michael; Möslang, Anton; Dafferner, Bernhard; Hoffmann, Jan [Karlsruhe Institute of Technology (KIT), Institute for Applied Materials (IAM-AWP) (Germany); Mrotzek, Tobias; Hoffmann, Andreas [PLANSEE SE, Reutte (Austria); Armstrong, D.E.J.; Yi, Xiaoou [University of Oxford, Department of Materials (United Kingdom)

    2013-05-15

    This paper is the fourth in our series on tungsten laminates. The aim of this paper is to discuss laminate synthesis, meaning the joining of tungsten foils. It is obvious that the properties of the tungsten laminate strongly depend on the combination of (i) interlayer and (ii) joining technology, as this combination defines (i) the condition of the tungsten foil after joining (as-received or recrystallised) as well as (ii) the characteristics of the interface between the tungsten foil and the interlayer (wettability or diffusion leading to a solid solution or the formation of intermetallics). From the example of tungsten laminates joined by brazing with (i) an eutectic silver copper brazing filler, (ii) copper, (iii) titanium, and (iv) zirconium, the microstructure will be discussed, with special focus on the interface. Based on our assumptions of the mechanism of the extraordinary ductility of tungsten foil we present three syntheses strategies and make recommendations for the synthesis of high temperature tungsten laminates.

  16. Joining of porous silicon carbide bodies

    Science.gov (United States)

    Bates, Carl H.; Couhig, John T.; Pelletier, Paul J.

    1990-05-01

    A method of joining two porous bodies of silicon carbide is disclosed. It entails utilizing an aqueous slip of a similar silicon carbide as was used to form the porous bodies, including the sintering aids, and a binder to initially join the porous bodies together. Then the composite structure is subjected to cold isostatic pressing to form a joint having good handling strength. Then the composite structure is subjected to pressureless sintering to form the final strong bond. Optionally, after the sintering the structure is subjected to hot isostatic pressing to further improve the joint and densify the structure. The result is a composite structure in which the joint is almost indistinguishable from the silicon carbide pieces which it joins.

  17. Modeling the effect of neighboring grains on twin growth in HCP polycrystals

    Science.gov (United States)

    Kumar, M. Arul; Beyerlein, I. J.; Lebensohn, R. A.; Tomé, C. N.

    2017-09-01

    In this paper, we study the dependence of neighboring grain orientation on the local stress state around a deformation twin in a hexagonal close packed (HCP) crystal and its effects on the resistance against twin thickening. We use a recently developed, full-field elasto-visco-plastic formulation based on fast Fourier transforms that account for the twinning shear transformation imposed by the twin lamella. The study is applied to Mg, Zr and Ti, since these HCP metals tend to deform by activation of different types of slip modes. The analysis shows that the local stress along the twin boundary are strongly controlled by the relative orientation of the easiest deformation modes in the neighboring grain with respect to the twin lamella in the parent grain. A geometric expression that captures this parent-neighbor relationship is proposed and incorporated into a larger scale, mean-field visco-plastic self-consistent model to simulate the role of neighboring grain orientation on twin thickening. We demonstrate that the approach improves the prediction of twin area fraction distribution when compared with experimental observations.

  18. OBEST: The Object-Based Event Scenario Tree Methodology

    International Nuclear Information System (INIS)

    WYSS, GREGORY D.; DURAN, FELICIA A.

    2001-01-01

    Event tree analysis and Monte Carlo-based discrete event simulation have been used in risk assessment studies for many years. This report details how features of these two methods can be combined with concepts from object-oriented analysis to develop a new risk assessment methodology with some of the best features of each. The resultant Object-Based Event Scenarios Tree (OBEST) methodology enables an analyst to rapidly construct realistic models for scenarios for which an a priori discovery of event ordering is either cumbersome or impossible (especially those that exhibit inconsistent or variable event ordering, which are difficult to represent in an event tree analysis). Each scenario produced by OBEST is automatically associated with a likelihood estimate because probabilistic branching is integral to the object model definition. The OBEST method uses a recursive algorithm to solve the object model and identify all possible scenarios and their associated probabilities. Since scenario likelihoods are developed directly by the solution algorithm, they need not be computed by statistical inference based on Monte Carlo observations (as required by some discrete event simulation methods). Thus, OBEST is not only much more computationally efficient than these simulation methods, but it also discovers scenarios that have extremely low probabilities as a natural analytical result--scenarios that would likely be missed by a Monte Carlo-based method. This report documents the OBEST methodology, the demonstration software that implements it, and provides example OBEST models for several different application domains, including interactions among failing interdependent infrastructure systems, circuit analysis for fire risk evaluation in nuclear power plants, and aviation safety studies

  19. Mixed random walks with a trap in scale-free networks including nearest-neighbor and next-nearest-neighbor jumps

    Science.gov (United States)

    Zhang, Zhongzhi; Dong, Yuze; Sheng, Yibin

    2015-10-01

    Random walks including non-nearest-neighbor jumps appear in many real situations such as the diffusion of adatoms and have found numerous applications including PageRank search algorithm; however, related theoretical results are much less for this dynamical process. In this paper, we present a study of mixed random walks in a family of fractal scale-free networks, where both nearest-neighbor and next-nearest-neighbor jumps are included. We focus on trapping problem in the network family, which is a particular case of random walks with a perfect trap fixed at the central high-degree node. We derive analytical expressions for the average trapping time (ATT), a quantitative indicator measuring the efficiency of the trapping process, by using two different methods, the results of which are consistent with each other. Furthermore, we analytically determine all the eigenvalues and their multiplicities for the fundamental matrix characterizing the dynamical process. Our results show that although next-nearest-neighbor jumps have no effect on the leading scaling of the trapping efficiency, they can strongly affect the prefactor of ATT, providing insight into better understanding of random-walk process in complex systems.

  20. A toolkit for visualizing the coherence of tree-based reordering with word-alignments

    NARCIS (Netherlands)

    Maillette de Buy Wenniger, G.; Khalilov, M.; Sima'an, K.

    2010-01-01

    Tree-based reordering constitutes an important motivation for the increasing interest in syntax-driven machine translation. It has often been argued that tree-based reordering might provide a more effective approach for bridging the word-order differences between source and target sentences. One

  1. Non-Destructive, Laser-Based Individual Tree Aboveground Biomass Estimation in a Tropical Rainforest

    Directory of Open Access Journals (Sweden)

    Muhammad Zulkarnain Abd Rahman

    2017-03-01

    Full Text Available Recent methods for detailed and accurate biomass and carbon stock estimation of forests have been driven by advances in remote sensing technology. The conventional approach to biomass estimation heavily relies on the tree species and site-specific allometric equations, which are based on destructive methods. This paper introduces a non-destructive, laser-based approach (terrestrial laser scanner for individual tree aboveground biomass estimation in the Royal Belum forest reserve, Perak, Malaysia. The study area is in the state park, and it is believed to be one of the oldest rainforests in the world. The point clouds generated for 35 forest plots, using the terrestrial laser scanner, were geo-rectified and cleaned to produce separate point clouds for individual trees. The volumes of tree trunks were estimated based on a cylinder model fitted to the point clouds. The biomasses of tree trunks were calculated by multiplying the volume and the species wood density. The biomasses of branches and leaves were also estimated based on the estimated volume and density values. Branch and leaf volumes were estimated based on the fitted point clouds using an alpha-shape approach. The estimated individual biomass and the total above ground biomass were compared with the aboveground biomass (AGB value estimated using existing allometric equations and individual tree census data collected in the field. The results show that the combination of a simple single-tree stem reconstruction and wood density can be used to estimate stem biomass comparable to the results usually obtained through existing allometric equations. However, there are several issues associated with the data and method used for branch and leaf biomass estimations, which need further improvement.

  2. Joining of SiC ceramics and SiC/SiC composites

    Energy Technology Data Exchange (ETDEWEB)

    Rabin, B.H. [Idaho National Engineering Lab., Idaho Falls, ID (United States)

    1996-08-01

    This project has successfully developed a practical and reliable method for fabricating SiC ceramic-ceramic joints. This joining method will permit the use of SiC-based ceramics in a variety of elevated temperature fossil energy applications. The technique is based on a reaction bonding approach that provides joint interlayers compatible with SiC, and excellent joint mechanical properties at temperatures exceeding 1000{degrees}C. Recent emphasis has been given to technology transfer activities, and several collaborative research efforts are in progress. Investigations are focusing on applying the joining method to sintered {alpha}-SiC and fiber-reinforced SiC/SiC composites for use in applications such as heat exchangers, radiant burners and gas turbine components.

  3. Efficient and accurate nearest neighbor and closest pair search in high-dimensional space

    KAUST Repository

    Tao, Yufei

    2010-07-01

    Nearest Neighbor (NN) search in high-dimensional space is an important problem in many applications. From the database perspective, a good solution needs to have two properties: (i) it can be easily incorporated in a relational database, and (ii) its query cost should increase sublinearly with the dataset size, regardless of the data and query distributions. Locality-Sensitive Hashing (LSH) is a well-known methodology fulfilling both requirements, but its current implementations either incur expensive space and query cost, or abandon its theoretical guarantee on the quality of query results. Motivated by this, we improve LSH by proposing an access method called the Locality-Sensitive B-tree (LSB-tree) to enable fast, accurate, high-dimensional NN search in relational databases. The combination of several LSB-trees forms a LSB-forest that has strong quality guarantees, but improves dramatically the efficiency of the previous LSH implementation having the same guarantees. In practice, the LSB-tree itself is also an effective index which consumes linear space, supports efficient updates, and provides accurate query results. In our experiments, the LSB-tree was faster than: (i) iDistance (a famous technique for exact NN search) by two orders ofmagnitude, and (ii) MedRank (a recent approximate method with nontrivial quality guarantees) by one order of magnitude, and meanwhile returned much better results. As a second step, we extend our LSB technique to solve another classic problem, called Closest Pair (CP) search, in high-dimensional space. The long-term challenge for this problem has been to achieve subquadratic running time at very high dimensionalities, which fails most of the existing solutions. We show that, using a LSB-forest, CP search can be accomplished in (worst-case) time significantly lower than the quadratic complexity, yet still ensuring very good quality. In practice, accurate answers can be found using just two LSB-trees, thus giving a substantial

  4. AnswerTree – a hyperplace-based game for collaborative mobile learning

    OpenAIRE

    Moore, Adam; Goulding, James; Brown, Elizabeth; Swan, Jerry

    2009-01-01

    In this paper we present AnswerTree, a collaborative mobile location-based educational game designed to teach 8-12 year olds about trees and wildlife within the University of Nottingham campus. The activity is designed around collecting virtual cards (similar in nature to the popular Top TrumpsTM games) containing graphics and information about notable trees. Each player begins by collecting one card from a game location, but then he or she can only collect further cards by answering question...

  5. Joining SiC/SiC composites for fusion applications

    International Nuclear Information System (INIS)

    Henager, C.J.

    2007-01-01

    Full text of publication follows: The use of SiC-reinforced composites for fusion reactors or other nuclear applications will likely require some form of joining in order to form large structural or functional sections. Joints must be able to allow load transfer to the composite material so that the fiber reinforcements are able to carry their designed loads and the joint should not fail in a brittle manner. In addition, joints must be tolerant of radiation damage similar to the composite material to maintain the structural integrity of the joined section. Other requirements of interest are low activation joints and ease of joining application and processing, which are a difficult set of criteria to meet. Research at PNNL has been directed at high-strength joints using solid-state displacement reactions and pre-ceramic polymer joints that are easy to apply and that could be used in field repair situations. This research will report on the further development and testing of such joints using a double notch shear (DNS) specimen that is suitable for in-reactor testing. The results reveal that the solid-state joints are stronger than the polymer-based joints but require high-temperature, high-pressure processing. The polymer-based joints can be applied with reduced pressure and temperature processing compared to the solid-state joints. The polymer-based joints may have adequate strength for some applications where ease of application and in situ processing are required. Although irradiation testing is not reported in this study the use of the DNS specimen is discussed with regard to future neutron irradiations. (authors)

  6. ACTION RECOGNITION USING SALIENT NEIGHBORING HISTOGRAMS

    DEFF Research Database (Denmark)

    Ren, Huamin; Moeslund, Thomas B.

    2013-01-01

    Combining spatio-temporal interest points with Bag-of-Words models achieves state-of-the-art performance in action recognition. However, existing methods based on “bag-ofwords” models either are too local to capture the variance in space/time or fail to solve the ambiguity problem in spatial...... and temporal dimensions. Instead, we propose a salient vocabulary construction algorithm to select visual words from a global point of view, and form compact descriptors to represent discriminative histograms in the neighborhoods. Those salient neighboring histograms are then trained to model different actions...

  7. Lectures on the nearest neighbor method

    CERN Document Server

    Biau, Gérard

    2015-01-01

    This text presents a wide-ranging and rigorous overview of nearest neighbor methods, one of the most important paradigms in machine learning. Now in one self-contained volume, this book systematically covers key statistical, probabilistic, combinatorial and geometric ideas for understanding, analyzing and developing nearest neighbor methods. Gérard Biau is a professor at Université Pierre et Marie Curie (Paris). Luc Devroye is a professor at the School of Computer Science at McGill University (Montreal).   .

  8. Dimensional testing for reverse k-nearest neighbor search

    DEFF Research Database (Denmark)

    Casanova, Guillaume; Englmeier, Elias; Houle, Michael E.

    2017-01-01

    Given a query object q, reverse k-nearest neighbor (RkNN) search aims to locate those objects of the database that have q among their k-nearest neighbors. In this paper, we propose an approximation method for solving RkNN queries, where the pruning operations and termination tests are guided...... by a characterization of the intrinsic dimensionality of the data. The method can accommodate any index structure supporting incremental (forward) nearest-neighbor search for the generation and verification of candidates, while avoiding impractically-high preprocessing costs. We also provide experimental evidence...

  9. Fermilab Friends for Science Education | Join Us

    Science.gov (United States)

    Fermilab Friends for Science Education FFSE Home About Us Join Us Support Us Contact Us Join Us improving science (science, technology, engineering and mathematics) education. Your donation allows us to membership dues allow us to create new, innovative science education programs, making the best use of unique

  10. Effects of local biotic neighbors and habitat heterogeneity on tree and shrub seedling survival in an old-growth temperate forest.

    Science.gov (United States)

    Bai, Xuejiao; Queenborough, Simon A; Wang, Xugao; Zhang, Jian; Li, Buhang; Yuan, Zuoqiang; Xing, Dingliang; Lin, Fei; Ye, Ji; Hao, Zhanqing

    2012-11-01

    Seedling dynamics play a crucial role in determining species distributions and coexistence. Exploring causes of variation in seedling dynamics can therefore provide key insights into the factors affecting these phenomena. We examined the relative importance of biotic neighborhood processes and habitat heterogeneity using survival data for 5,827 seedlings in 39 tree and shrub species over 2 years from an old-growth temperate forest in northeastern China. We found significant negative density-dependence effects on survival of tree seedlings, and limited effects of habitat heterogeneity (edaphic and topographic variables) on survival of shrub seedlings. The importance of negative density dependence on young tree seedling survival was replaced by habitat in tree seedlings ≥ 4 years old. As expected, negative density dependence was more apparent in gravity-dispersed species compared to wind-dispersed and animal-dispersed species. Moreover, we found that a community compensatory trend existed for trees. Therefore, although negative density dependence was not as pervasive as in other forest communities, it is an important mechanism for the maintenance of community diversity in this temperate forest. We conclude that both negative density dependence and habitat heterogeneity drive seedling survival, but their relative importance varies with seedling age classes and species traits.

  11. Dissimilar material joining using laser (aluminum to steel using zinc-based filler wire)

    Science.gov (United States)

    Mathieu, Alexandre; Shabadi, Rajashekar; Deschamps, Alexis; Suery, Michel; Matteï, Simone; Grevey, Dominique; Cicala, Eugen

    2007-04-01

    Joining steel with aluminum involving the fusion of one or both materials is possible by laser beam welding technique. This paper describes a method, called laser braze welding, which is a suitable process to realize this structure. The main problem with thermal joining of steel/aluminum assembly with processes such as TIG or MIG is the formation of fragile intermetallic phases, which are detrimental to the mechanical performances of such joints. Braze welding permits a localized fusion of the materials resulting in a limitation on the growth of fragile phases. This article presents the results of a statistical approach for an overlap assembly configuration using a filler wire composed of 85% Zn and 15% Al. Tensile tests carried on these assemblies demonstrate a good performance of the joints. The fracture mechanisms of the joints are analyzed by a detailed characterization of the seams.

  12. Potentials of Industrie 4.0 and Machine Learning for Mechanical Joining

    OpenAIRE

    Jäckel, Mathias

    2017-01-01

    -Sensitivity analysis of the influence of component properties and joining parameters on the joining result for self-pierce riveting -Possibilities to link mechanical joining technologies with the automotive process chain for quality and flexibility improvements -Potential of using machine learning to reduce automotive product development cycles in relation to mechanical joining -Datamining for machine learning at mechanical joining

  13. Reset Tree-Based Optical Fault Detection

    Directory of Open Access Journals (Sweden)

    Howon Kim

    2013-05-01

    Full Text Available In this paper, we present a new reset tree-based scheme to protect cryptographic hardware against optical fault injection attacks. As one of the most powerful invasive attacks on cryptographic hardware, optical fault attacks cause semiconductors to misbehave by injecting high-energy light into a decapped integrated circuit. The contaminated result from the affected chip is then used to reveal secret information, such as a key, from the cryptographic hardware. Since the advent of such attacks, various countermeasures have been proposed. Although most of these countermeasures are strong, there is still the possibility of attack. In this paper, we present a novel optical fault detection scheme that utilizes the buffers on a circuit’s reset signal tree as a fault detection sensor. To evaluate our proposal, we model radiation-induced currents into circuit components and perform a SPICE simulation. The proposed scheme is expected to be used as a supplemental security tool.

  14. Learning in data-limited multimodal scenarios: Scandent decision forests and tree-based features.

    Science.gov (United States)

    Hor, Soheil; Moradi, Mehdi

    2016-12-01

    Incomplete and inconsistent datasets often pose difficulties in multimodal studies. We introduce the concept of scandent decision trees to tackle these difficulties. Scandent trees are decision trees that optimally mimic the partitioning of the data determined by another decision tree, and crucially, use only a subset of the feature set. We show how scandent trees can be used to enhance the performance of decision forests trained on a small number of multimodal samples when we have access to larger datasets with vastly incomplete feature sets. Additionally, we introduce the concept of tree-based feature transforms in the decision forest paradigm. When combined with scandent trees, the tree-based feature transforms enable us to train a classifier on a rich multimodal dataset, and use it to classify samples with only a subset of features of the training data. Using this methodology, we build a model trained on MRI and PET images of the ADNI dataset, and then test it on cases with only MRI data. We show that this is significantly more effective in staging of cognitive impairments compared to a similar decision forest model trained and tested on MRI only, or one that uses other kinds of feature transform applied to the MRI data. Copyright © 2016. Published by Elsevier B.V.

  15. Study on reliability analysis based on multilevel flow models and fault tree method

    International Nuclear Information System (INIS)

    Chen Qiang; Yang Ming

    2014-01-01

    Multilevel flow models (MFM) and fault tree method describe the system knowledge in different forms, so the two methods express an equivalent logic of the system reliability under the same boundary conditions and assumptions. Based on this and combined with the characteristics of MFM, a method mapping MFM to fault tree was put forward, thus providing a way to establish fault tree rapidly and realizing qualitative reliability analysis based on MFM. Taking the safety injection system of pressurized water reactor nuclear power plant as an example, its MFM was established and its reliability was analyzed qualitatively. The analysis result shows that the logic of mapping MFM to fault tree is correct. The MFM is easily understood, created and modified. Compared with the traditional fault tree analysis, the workload is greatly reduced and the modeling time is saved. (authors)

  16. Mitochondrial COI and morphological specificity of the mealy aphids (Hyalopterus ssp. collected from different hosts in Europe (Hemiptera, Aphididae

    Directory of Open Access Journals (Sweden)

    Rimantas Rakauskas

    2013-07-01

    Full Text Available Forty three European population samples of mealy aphids from various winter and summer host plants were attributed to respective species of Hyalopterus by means of their partial sequences of mitochondrial COI gene. Used Hyalopterus samples emerged as monophyletic relative to outgroup and formed three major clades representing three host specific mealy aphid species in the Neighbor joining, Maximum parsimony, Maximum likelihood and Bayesian inference trees. H. pruni and H. persikonus emerged as a sister species, whilst H. amygdali was located basally. Samples representing different clades in the molecular trees were used for canonical discrimination analysis based on twenty two morphological characters. Length of the median dorsal head hair enabled a 97.3 % separation of H. amygdali from the remaining two species. No single character enabled satisfactory discrimination between apterous viviparous females of H. pruni and H. persikonus. A modified key for the morphological identification of Hyalopterus species is suggested and their taxonomic status discussed.

  17. TreePOD: Sensitivity-Aware Selection of Pareto-Optimal Decision Trees.

    Science.gov (United States)

    Muhlbacher, Thomas; Linhardt, Lorenz; Moller, Torsten; Piringer, Harald

    2018-01-01

    Balancing accuracy gains with other objectives such as interpretability is a key challenge when building decision trees. However, this process is difficult to automate because it involves know-how about the domain as well as the purpose of the model. This paper presents TreePOD, a new approach for sensitivity-aware model selection along trade-offs. TreePOD is based on exploring a large set of candidate trees generated by sampling the parameters of tree construction algorithms. Based on this set, visualizations of quantitative and qualitative tree aspects provide a comprehensive overview of possible tree characteristics. Along trade-offs between two objectives, TreePOD provides efficient selection guidance by focusing on Pareto-optimal tree candidates. TreePOD also conveys the sensitivities of tree characteristics on variations of selected parameters by extending the tree generation process with a full-factorial sampling. We demonstrate how TreePOD supports a variety of tasks involved in decision tree selection and describe its integration in a holistic workflow for building and selecting decision trees. For evaluation, we illustrate a case study for predicting critical power grid states, and we report qualitative feedback from domain experts in the energy sector. This feedback suggests that TreePOD enables users with and without statistical background a confident and efficient identification of suitable decision trees.

  18. Investigation on electrical tree propagation in polyethylene based on etching method

    Directory of Open Access Journals (Sweden)

    Zexiang Shi

    2017-11-01

    Full Text Available To investigate the characteristic of electrical tree propagation in semi-crystalline polymers, the low-density polyethylene (LDPE samples containing electrical trees are cut into slices by using ultramicrotome. Then the slice samples are etched by potassium permanganate etchant. Finally, the crystalline structure and the electrical tree propagation path in samples are observed by polarized light microscopy (PLM. According to the observation, the LDPE spherocrystal structure model is established on the basis of crystallization kinetics and morphology of polymers. And the electrical tree growth process in LDPE is discussed based on the free volume breakdown theory, the molecular chain relaxation theory, the electromechanical force theory, the thermal expansion effect and the space charge shielding effect.

  19. A Weibull-based compositional approach for hierarchical dynamic fault trees

    International Nuclear Information System (INIS)

    Chiacchio, F.; Cacioppo, M.; D'Urso, D.; Manno, G.; Trapani, N.; Compagno, L.

    2013-01-01

    The solution of a dynamic fault tree (DFT) for the reliability assessment can be achieved using a wide variety of techniques. These techniques have a strong theoretical foundation as both the analytical and the simulation methods have been extensively developed. Nevertheless, they all present the same limits that appear with the increasing of the size of the fault trees (i.e., state space explosion, time-consuming simulations), compromising the resolution. We have tested the feasibility of a composition algorithm based on a Weibull distribution, addressed to the resolution of a general class of dynamic fault trees characterized by non-repairable basic events and generally distributed failure times. The proposed composition algorithm is used to generalize the traditional hierarchical technique that, as previous literature have extensively confirmed, is able to reduce the computational effort of a large DFT through the modularization of independent parts of the tree. The results of this study are achieved both through simulation and analytical techniques, thus confirming the capability to solve a quite general class of dynamic fault trees and overcome the limits of traditional techniques.

  20. Trend and Development of Semisolid Metal Joining Processing

    Directory of Open Access Journals (Sweden)

    M. N. Mohammed

    2015-01-01

    Full Text Available The semisolid metal joining (SSMJ process or thixojoining process has recently been developed based on the principles of SSM processing, which is a technology that involves the formation of metal alloys between solidus and liquidus temperatures. Thixojoining has many potential benefits, which has encouraged researchers to carry out feasibility studies on various materials that could be utilized in this process and which could transform the production of metal components. This paper reviews the findings in the literature to date in this evolving field, specifically, the experimental details, technology considerations for industrialization, and advantages and disadvantages of the various types of SSMJ methods that have been proposed. It also presents details of the range of materials that have been joined by using the SSMJ process. Furthermore, it highlights the huge potential of this process and future directions for further research.

  1. Performance modeling of neighbor discovery in proactive routing protocols

    Directory of Open Access Journals (Sweden)

    Andres Medina

    2011-07-01

    Full Text Available It is well known that neighbor discovery is a critical component of proactive routing protocols in wireless ad hoc networks. However there is no formal study on the performance of proposed neighbor discovery mechanisms. This paper provides a detailed model of key performance metrics of neighbor discovery algorithms, such as node degree and the distribution of the distance to symmetric neighbors. The model accounts for the dynamics of neighbor discovery as well as node density, mobility, radio and interference. The paper demonstrates a method for applying these models to the evaluation of global network metrics. In particular, it describes a model of network connectivity. Validation of the models shows that the degree estimate agrees, within 5% error, with simulations for the considered scenarios. The work presented in this paper serves as a basis for the performance evaluation of remaining performance metrics of routing protocols, vital for large scale deployment of ad hoc networks.

  2. A SURVEY ON DELAY AND NEIGHBOR NODE MONITORING BASED WORMHOLE ATTACK PREVENTION AND DETECTION

    Directory of Open Access Journals (Sweden)

    Sudhir T Bagade

    2016-12-01

    Full Text Available In Mobile Ad-hoc Networks (MANET, network layer attacks, for example wormhole attacks, disrupt the network routing operations and can be used for data theft. Wormhole attacks are of two types: hidden and exposed wormhole. There are various mechanisms in literature which are used to prevent and detect wormhole attacks. In this paper, we survey wormhole prevention and detection techniques and present our critical observations for each. These techniques are based on cryptographic mechanisms, monitoring of packet transmission delay and control packet forwarding behavior of neighbor nodes. We compare the techniques using the following criteria- extra resources needed applicability to different network topologies and routing protocols, prevention/detection capability, etc. We conclude the paper with potential research directions.

  3. Mitochondrial DNA-based identification of some forensically important blowflies in Thailand.

    Science.gov (United States)

    Preativatanyou, Kanok; Sirisup, Nantana; Payungporn, Sunchai; Poovorawan, Yong; Thavara, Usavadee; Tawatsin, Apiwat; Sungpradit, Sivapong; Siriyasatien, Padet

    2010-10-10

    Accurate identification of insects collected from death scenes provides not only specific developmental data assisting forensic entomologists to determine the postmortem interval more precisely but also other kinds of forensic evidence. However, morphological identification can be complicated due to the similarity among species, especially in the early larval stages. To simplify and make the species identification more practical and reliable, DNA-based identification is preferentially considered. In this study, we demonstrate the application of partial mitochondrial cytochrome oxidase I (COI) and cytochrome oxidase II (COII) sequences for differentiation of forensically important blowflies in Thailand; Chrysomya megacephala, Chrysomya rufifacies and Lucilia cuprina by polymerase chain reaction-restriction fragment length polymorphism (PCR-RFLP). The PCR yields a single 1324bp-sized amplicon in all blowfly specimens, followed by direct DNA sequencing. Taq(α)I and VspI predicted from the sequencing data provide different RFLP profiles among these three species. Sequence analysis reveals no significant intraspecific divergence in blowfly specimens captured from different geographical regions in Thailand. Accordingly, neighbor-joining tree using Kimura's 2-parameter model illustrates reciprocal monophyly between species. Thus, these approaches serve as promising tools for molecular identification of these three common forensically important blowfly species in Thailand. Copyright © 2010 Elsevier Ireland Ltd. All rights reserved.

  4. Discriminative Hierarchical K-Means Tree for Large-Scale Image Classification.

    Science.gov (United States)

    Chen, Shizhi; Yang, Xiaodong; Tian, Yingli

    2015-09-01

    A key challenge in large-scale image classification is how to achieve efficiency in terms of both computation and memory without compromising classification accuracy. The learning-based classifiers achieve the state-of-the-art accuracies, but have been criticized for the computational complexity that grows linearly with the number of classes. The nonparametric nearest neighbor (NN)-based classifiers naturally handle large numbers of categories, but incur prohibitively expensive computation and memory costs. In this brief, we present a novel classification scheme, i.e., discriminative hierarchical K-means tree (D-HKTree), which combines the advantages of both learning-based and NN-based classifiers. The complexity of the D-HKTree only grows sublinearly with the number of categories, which is much better than the recent hierarchical support vector machines-based methods. The memory requirement is the order of magnitude less than the recent Naïve Bayesian NN-based approaches. The proposed D-HKTree classification scheme is evaluated on several challenging benchmark databases and achieves the state-of-the-art accuracies, while with significantly lower computation cost and memory requirement.

  5. A Hybrid Vector Quantization Combining a Tree Structure and a Voronoi Diagram

    Directory of Open Access Journals (Sweden)

    Yeou-Jiunn Chen

    2014-01-01

    Full Text Available Multimedia data is a popular communication medium, but requires substantial storage space and network bandwidth. Vector quantization (VQ is suitable for multimedia data applications because of its simple architecture, fast decoding ability, and high compression rate. Full-search VQ can typically be used to determine optimal codewords, but requires considerable computational time and resources. In this study, a hybrid VQ combining a tree structure and a Voronoi diagram is proposed to improve VQ efficiency. To efficiently reduce the search space, a tree structure integrated with principal component analysis is proposed, to rapidly determine an initial codeword in low-dimensional space. To increase accuracy, a Voronoi diagram is applied to precisely enlarge the search space by modeling relations between each codeword. This enables an optimal codeword to be efficiently identified by rippling an optimal neighbor from parts of neighboring Voronoi regions. The experimental results demonstrated that the proposed approach improved VQ performance, outperforming other approaches. The proposed approach also satisfies the requirements of handheld device application, namely, the use of limited memory and network bandwidth, when a suitable number of dimensions in principal component analysis is selected.

  6. New flux based dose–response relationships for ozone for European forest tree species

    International Nuclear Information System (INIS)

    Büker, P.; Feng, Z.; Uddling, J.; Briolat, A.; Alonso, R.; Braun, S.; Elvira, S.; Gerosa, G.; Karlsson, P.E.; Le Thiec, D.

    2015-01-01

    To derive O 3 dose–response relationships (DRR) for five European forest trees species and broadleaf deciduous and needleleaf tree plant functional types (PFTs), phytotoxic O 3 doses (PODy) were related to biomass reductions. PODy was calculated using a stomatal flux model with a range of cut-off thresholds (y) indicative of varying detoxification capacities. Linear regression analysis showed that DRR for PFT and individual tree species differed in their robustness. A simplified parameterisation of the flux model was tested and showed that for most non-Mediterranean tree species, this simplified model led to similarly robust DRR as compared to a species- and climate region-specific parameterisation. Experimentally induced soil water stress was not found to substantially reduce PODy, mainly due to the short duration of soil water stress periods. This study validates the stomatal O 3 flux concept and represents a step forward in predicting O 3 damage to forests in a spatially and temporally varying climate. - Highlights: • We present new ozone flux based dose–response relationships for European trees. • The model-based study accounted for the soil water effect on stomatal flux. • Different statistically derived ozone flux thresholds were applied. • Climate region specific parameterisation often outperformed simplified parameterisation. • Findings could help redefining critical levels for ozone effects on trees. - New stomatal flux based ozone dose–response relationships for tree species are derived for the regional risk assessment of ozone effects on European forest ecosystems.

  7. Spin canting in a Dy-based single-chain magnet with dominant next-nearest-neighbor antiferromagnetic interactions

    Science.gov (United States)

    Bernot, K.; Luzon, J.; Caneschi, A.; Gatteschi, D.; Sessoli, R.; Bogani, L.; Vindigni, A.; Rettori, A.; Pini, M. G.

    2009-04-01

    We investigate theoretically and experimentally the static magnetic properties of single crystals of the molecular-based single-chain magnet of formula [Dy(hfac)3NIT(C6H4OPh)]∞ comprising alternating Dy3+ and organic radicals. The magnetic molar susceptibility χM displays a strong angular variation for sample rotations around two directions perpendicular to the chain axis. A peculiar inversion between maxima and minima in the angular dependence of χM occurs on increasing temperature. Using information regarding the monomeric building block as well as an ab initio estimation of the magnetic anisotropy of the Dy3+ ion, this “anisotropy-inversion” phenomenon can be assigned to weak one-dimensional ferromagnetism along the chain axis. This indicates that antiferromagnetic next-nearest-neighbor interactions between Dy3+ ions dominate, despite the large Dy-Dy separation, over the nearest-neighbor interactions between the radicals and the Dy3+ ions. Measurements of the field dependence of the magnetization, both along and perpendicularly to the chain, and of the angular dependence of χM in a strong magnetic field confirm such an interpretation. Transfer-matrix simulations of the experimental measurements are performed using a classical one-dimensional spin model with antiferromagnetic Heisenberg exchange interaction and noncollinear uniaxial single-ion anisotropies favoring a canted antiferromagnetic spin arrangement, with a net magnetic moment along the chain axis. The fine agreement obtained with experimental data provides estimates of the Hamiltonian parameters, essential for further study of the dynamics of rare-earth-based molecular chains.

  8. Explicit area-based accuracy assessment for mangrove tree crown delineation using Geographic Object-Based Image Analysis (GEOBIA)

    Science.gov (United States)

    Kamal, Muhammad; Johansen, Kasper

    2017-10-01

    Effective mangrove management requires spatially explicit information of mangrove tree crown map as a basis for ecosystem diversity study and health assessment. Accuracy assessment is an integral part of any mapping activities to measure the effectiveness of the classification approach. In geographic object-based image analysis (GEOBIA) the assessment of the geometric accuracy (shape, symmetry and location) of the created image objects from image segmentation is required. In this study we used an explicit area-based accuracy assessment to measure the degree of similarity between the results of the classification and reference data from different aspects, including overall quality (OQ), user's accuracy (UA), producer's accuracy (PA) and overall accuracy (OA). We developed a rule set to delineate the mangrove tree crown using WorldView-2 pan-sharpened image. The reference map was obtained by visual delineation of the mangrove tree crowns boundaries form a very high-spatial resolution aerial photograph (7.5cm pixel size). Ten random points with a 10 m radius circular buffer were created to calculate the area-based accuracy assessment. The resulting circular polygons were used to clip both the classified image objects and reference map for area comparisons. In this case, the area-based accuracy assessment resulted 64% and 68% for the OQ and OA, respectively. The overall quality of the calculation results shows the class-related area accuracy; which is the area of correctly classified as tree crowns was 64% out of the total area of tree crowns. On the other hand, the overall accuracy of 68% was calculated as the percentage of all correctly classified classes (tree crowns and canopy gaps) in comparison to the total class area (an entire image). Overall, the area-based accuracy assessment was simple to implement and easy to interpret. It also shows explicitly the omission and commission error variations of object boundary delineation with colour coded polygons.

  9. A review of the US joining technologies for plasma facing components in the ITER fusion reactor

    International Nuclear Information System (INIS)

    Odegard, B.C. Jr.; Cadden, C.H.; Watson, R.D.; Slattery, K.T.

    1998-02-01

    This paper is a review of the current joining technologies for plasma facing components in the US for the International Thermonuclear Experimental Reactor (ITER) project. Many facilities are involved in this project. Many unique and innovative joining techniques are being considered in the quest to join two candidate armor plate materials (beryllium and tungsten) to a copper base alloy heat sink (CuNiBe, OD copper, CuCrZr). These techniques include brazing and diffusion bonding, compliant layers at the bond interface, and the use of diffusion barrier coatings and diffusion enhancing coatings at the bond interfaces. The development and status of these joining techniques will be detailed in this report

  10. Similarity joins in relational database systems

    CERN Document Server

    Augsten, Nikolaus

    2013-01-01

    State-of-the-art database systems manage and process a variety of complex objects, including strings and trees. For such objects equality comparisons are often not meaningful and must be replaced by similarity comparisons. This book describes the concepts and techniques to incorporate similarity into database systems. We start out by discussing the properties of strings and trees, and identify the edit distance as the de facto standard for comparing complex objects. Since the edit distance is computationally expensive, token-based distances have been introduced to speed up edit distance comput

  11. Loosening and damage mechanism of thread-joined structures in nuclear power equipment

    International Nuclear Information System (INIS)

    Tang Hui

    1999-01-01

    The author proposes a loosening mechanism of thread-joined structures under vibrate environments in the nuclear power equipment and structures, which is on the base of the macro and imperceptible-mechanics analysis. It has answered the problems on the seizing, the adhesive wearing, the generation of cracks, the thread-tooth fracture. So it has a conclusion that the loosening of thread-joined structures is essential trend, in other words, the locking property of thread-pair is failure under vibrate environments

  12. Joining Dental Ceramic Layers With Glass

    Science.gov (United States)

    Saied, MA; Lloyd, IK; Haller, WK; Lawn, BR

    2011-01-01

    Objective Test the hypothesis that glass-bonding of free-form veneer and core ceramic layers can produce robust interfaces, chemically durable and aesthetic in appearance and, above all, resistant to delamination. Methods Layers of independently produced porcelains (NobelRondo™ Press porcelain, Nobel BioCare AB and Sagkura Interaction porcelain, Elephant Dental) and matching alumina or zirconia core ceramics (Procera alumina, Nobel BioCare AB, BioZyram yttria stabilized tetragonal zirconia polycrystal, Cyrtina Dental) were joined with designed glasses, tailored to match thermal expansion coefficients of the components and free of toxic elements. Scanning electron microprobe analysis was used to characterize the chemistry of the joined interfaces, specifically to confirm interdiffusion of ions. Vickers indentations were used to drive controlled corner cracks into the glass interlayers to evaluate the toughness of the interfaces. Results The glass-bonded interfaces were found to have robust integrity relative to interfaces fused without glass, or those fused with a resin-based adhesive. Significance The structural integrity of the interfaces between porcelain veneers and alumina or zirconia cores is a critical factor in the longevity of all-ceramic dental crowns and fixed dental prostheses. PMID:21802131

  13. Contribution to the joining technique of SiC-ceramic using metallic interlayers

    International Nuclear Information System (INIS)

    Gottselig, B.; Gyarmati, E.; Naoumidis, A.; Nickel, H.

    1989-07-01

    For ceramics to be feasible for technical uses suitable joining techniques must be developed that allow reliable ceramic-ceramic and ceramic-metal connections. As yet such procedures exist, based only on empirical studies omitting the reaction behaviour of the joining materials and the specific properties of the reaction products. For this reason the reaction behaviour of silicon carbide with selected metals and subsequently the compatibility of these reaction layers with the ceramic substrate were investigated. The results gained were then applied to silicon carbide joints using intermediate metallic layers. With the reaction phase Ti 3 SiC 2 , found to be the most suitable in basic experiments, joining strengths could be obtained relative tc the mean strength and Weibull modulus comparable to those of the ceramic starting material. (orig.) [de

  14. Enabling Dissimilar Material Joining Using Friction Stir Scribe Technology

    Energy Technology Data Exchange (ETDEWEB)

    Hovanski, Yuri; Upadyay, Piyush; Kleinbaum, Sarah; Carlson, Blair; Boettcher, Eric; Ruokolainen, Robert

    2017-04-05

    One challenge in adapting welding processes to dissimilar material joining is the diversity of melting temperatures of the different materials. Although the use of mechanical fasteners and adhesives have mostly paved the way for near-term implementation of dissimilar material systems, these processes only accentuate the need for low-cost welding processes capable of joining dissimilar material components regardless of alloy, properties, or melting temperature. Friction stir scribe technology was developed to overcome the challenges of joining dissimilar material components where melting temperatures vary greatly, and properties and/or chemistry are not compatible with more traditional welding processes. Although the friction stir scribe process is capable of joining dissimilar metals and metal/polymer systems, a more detailed evaluation of several aluminum/steel joints is presented herein to demonstrate the ability to both chemically and mechanically join dissimilar materials.

  15. Development of low temperature solid state joining technology of dissimilar for nuclear heat exchanger tube components

    Energy Technology Data Exchange (ETDEWEB)

    NONE

    2010-08-15

    By conventional fusion welding process (TIG), a realization of reliable and sound joints for the nuclear heat exchanger components is very difficult, especially for the parts comprising of the dissimilar metal couples (Ti-STS, Ti-Cu alloy etc.). This is mainly attributed to the formation of brittle intermetallics (Ti{sub x}Cu{sub y}, Ti{sub x}Fe{sub y}, Ti{sub x}Ni{sub y} etc.) and wide difference in physical properties. Moreover, it usually employs very high thermal input, so making it difficult to obtain sound joints due to generations of high residual stresses and degradation of the adjacent base metals, even for similar metal combinations. In this project, the low temperature solid-state joining technology was established by developing new alloy fillers, e.g. the multi-component eutectic based alloys or amorphous alloys, and thereby lowering the joining temperature down to {approx}800 .deg. C without affecting the structural properties of base metals. Based on a low temperature joining, the interlayer engineering technology was then developed to be able to eliminate the brittleness of the joints for strong Ti-STS dissimilar joints, and the diffusion brazing technology of Ti-Ti with a superior joining strength and corrosion-resistance comparable to those of base metal were developed. By using those developed technologies, the joining procedures feasible for the heat exchanger components were finally established for the dissimilar metal joints including Ti tube sheet to super STS tube, Ti tube sheet to super STS tube sheet, and the joints of the Ti tube to Ti tube sheet

  16. The surprising power of neighborly advice.

    Science.gov (United States)

    Gilbert, Daniel T; Killingsworth, Matthew A; Eyre, Rebecca N; Wilson, Timothy D

    2009-03-20

    Two experiments revealed that (i) people can more accurately predict their affective reactions to a future event when they know how a neighbor in their social network reacted to the event than when they know about the event itself and (ii) people do not believe this. Undergraduates made more accurate predictions about their affective reactions to a 5-minute speed date (n = 25) and to a peer evaluation (n = 88) when they knew only how another undergraduate had reacted to these events than when they had information about the events themselves. Both participants and independent judges mistakenly believed that predictions based on information about the event would be more accurate than predictions based on information about how another person had reacted to it.

  17. Runtime Optimizations for Tree-Based Machine Learning Models

    NARCIS (Netherlands)

    N. Asadi; J.J.P. Lin (Jimmy); A.P. de Vries (Arjen)

    2014-01-01

    htmlabstractTree-based models have proven to be an effective solution for web ranking as well as other machine learning problems in diverse domains. This paper focuses on optimizing the runtime performance of applying such models to make predictions, specifically using gradient-boosted regression

  18. Understanding the Roles of Forests and Tree-based Systems in Food Provision

    NARCIS (Netherlands)

    Jamnadass, R.; McMullin, S.; Dawson, M.I.I.K.; Powell, B.; Termote, C.; Lckowitz, A.; Kehlenbeck, K.; Vinceti, B.; Vliet, van N.; Keding, G.; Stadlmayr, B.; Damme, van P.; Carsan, S.; Sunderland, T.; Njenga, M.; Gyau, A.; Cerutti, P.; Schure, J.M.; Kouame, C.; Obiri, B.D.; Ofori, D.; Agarwal, B.; Neufeldt, H.; Degrande, A.; Serban, A.

    2015-01-01

    Forests and other tree-based systems such as agroforestry contribute to food and nutritional security in myriad ways. Directly, trees provide a variety of healthy foods including fruits, leafy vegetables, nuts, seeds and edible oils that can diversify diets and address seasonal food and nutritional

  19. A Novel Hybrid Model Based on Extreme Learning Machine, k-Nearest Neighbor Regression and Wavelet Denoising Applied to Short-Term Electric Load Forecasting

    Directory of Open Access Journals (Sweden)

    Weide Li

    2017-05-01

    Full Text Available Electric load forecasting plays an important role in electricity markets and power systems. Because electric load time series are complicated and nonlinear, it is very difficult to achieve a satisfactory forecasting accuracy. In this paper, a hybrid model, Wavelet Denoising-Extreme Learning Machine optimized by k-Nearest Neighbor Regression (EWKM, which combines k-Nearest Neighbor (KNN and Extreme Learning Machine (ELM based on a wavelet denoising technique is proposed for short-term load forecasting. The proposed hybrid model decomposes the time series into a low frequency-associated main signal and some detailed signals associated with high frequencies at first, then uses KNN to determine the independent and dependent variables from the low-frequency signal. Finally, the ELM is used to get the non-linear relationship between these variables to get the final prediction result for the electric load. Compared with three other models, Extreme Learning Machine optimized by k-Nearest Neighbor Regression (EKM, Wavelet Denoising-Extreme Learning Machine (WKM and Wavelet Denoising-Back Propagation Neural Network optimized by k-Nearest Neighbor Regression (WNNM, the model proposed in this paper can improve the accuracy efficiently. New South Wales is the economic powerhouse of Australia, so we use the proposed model to predict electric demand for that region. The accurate prediction has a significant meaning.

  20. A support vector machine based test for incongruence between sets of trees in tree space

    Science.gov (United States)

    2012-01-01

    Background The increased use of multi-locus data sets for phylogenetic reconstruction has increased the need to determine whether a set of gene trees significantly deviate from the phylogenetic patterns of other genes. Such unusual gene trees may have been influenced by other evolutionary processes such as selection, gene duplication, or horizontal gene transfer. Results Motivated by this problem we propose a nonparametric goodness-of-fit test for two empirical distributions of gene trees, and we developed the software GeneOut to estimate a p-value for the test. Our approach maps trees into a multi-dimensional vector space and then applies support vector machines (SVMs) to measure the separation between two sets of pre-defined trees. We use a permutation test to assess the significance of the SVM separation. To demonstrate the performance of GeneOut, we applied it to the comparison of gene trees simulated within different species trees across a range of species tree depths. Applied directly to sets of simulated gene trees with large sample sizes, GeneOut was able to detect very small differences between two set of gene trees generated under different species trees. Our statistical test can also include tree reconstruction into its test framework through a variety of phylogenetic optimality criteria. When applied to DNA sequence data simulated from different sets of gene trees, results in the form of receiver operating characteristic (ROC) curves indicated that GeneOut performed well in the detection of differences between sets of trees with different distributions in a multi-dimensional space. Furthermore, it controlled false positive and false negative rates very well, indicating a high degree of accuracy. Conclusions The non-parametric nature of our statistical test provides fast and efficient analyses, and makes it an applicable test for any scenario where evolutionary or other factors can lead to trees with different multi-dimensional distributions. The

  1. Individual tree detection based on densities of high points of high resolution airborne lidar

    NARCIS (Netherlands)

    Abd Rahman, M.Z.; Gorte, B.G.H.

    2008-01-01

    The retrieval of individual tree location from Airborne LiDAR has focused largely on utilizing canopy height. However, high resolution Airborne LiDAR offers another source of information for tree detection. This paper presents a new method for tree detection based on high points’ densities from a

  2. False discovery rate control incorporating phylogenetic tree increases detection power in microbiome-wide multiple testing.

    Science.gov (United States)

    Xiao, Jian; Cao, Hongyuan; Chen, Jun

    2017-09-15

    Next generation sequencing technologies have enabled the study of the human microbiome through direct sequencing of microbial DNA, resulting in an enormous amount of microbiome sequencing data. One unique characteristic of microbiome data is the phylogenetic tree that relates all the bacterial species. Closely related bacterial species have a tendency to exhibit a similar relationship with the environment or disease. Thus, incorporating the phylogenetic tree information can potentially improve the detection power for microbiome-wide association studies, where hundreds or thousands of tests are conducted simultaneously to identify bacterial species associated with a phenotype of interest. Despite much progress in multiple testing procedures such as false discovery rate (FDR) control, methods that take into account the phylogenetic tree are largely limited. We propose a new FDR control procedure that incorporates the prior structure information and apply it to microbiome data. The proposed procedure is based on a hierarchical model, where a structure-based prior distribution is designed to utilize the phylogenetic tree. By borrowing information from neighboring bacterial species, we are able to improve the statistical power of detecting associated bacterial species while controlling the FDR at desired levels. When the phylogenetic tree is mis-specified or non-informative, our procedure achieves a similar power as traditional procedures that do not take into account the tree structure. We demonstrate the performance of our method through extensive simulations and real microbiome datasets. We identified far more alcohol-drinking associated bacterial species than traditional methods. R package StructFDR is available from CRAN. chen.jun2@mayo.edu. Supplementary data are available at Bioinformatics online. © The Author (2017). Published by Oxford University Press. All rights reserved. For Permissions, please email: journals.permissions@oup.com

  3. Temperature profile in apricot tree canopies under the soil and climate conditions of the Romanian Black Sea Coast

    Science.gov (United States)

    Paltineanu, Cristian; Septar, Leinar; Chitu, Emil

    2016-03-01

    The paper describes the temperature profiles determined by thermal imagery in apricot tree canopies under the semi-arid conditions of the Black Sea Coast in a chernozem of Dobrogea Region, Romania. The study analyzes the thermal vertical profile of apricot orchards for three representative cultivars during summertime. Measurements were done when the soil water content (SWC) was at field capacity (FC) within the rooting depth, after intense sprinkler irrigation applications. Canopy temperature was measured during clear sky days at three heights for both sides of the apricot trees, sunlit (south), and shaded (north). For the SWC studied, i.e., FC, canopy height did not induce a significant difference between the temperature of apricot tree leaves (Tc) and the ambient air temperature (Ta) within the entire vertical tree profile, and temperature measurements by thermal imagery can therefore be taken at any height on the tree crown leaves. Differences between sunlit and shaded sides of the canopy were significant. Because of these differences for Tc-Ta among the apricot tree cultivars studied, lower base lines (LBLs) should be determined for each cultivar separately. The use of thermal imagery technique under the conditions of semi-arid coastal areas with low range of vapor pressure deficit could be useful in irrigation scheduling of apricot trees. The paper discusses the implications of the data obtained in the experiment under the conditions of the coastal area of the Black Sea, Romania, and neighboring countries with similar climate, such as Bulgaria and Turkey.

  4. Selection bias in species distribution models: An econometric approach on forest trees based on structural modeling

    Science.gov (United States)

    Martin-StPaul, N. K.; Ay, J. S.; Guillemot, J.; Doyen, L.; Leadley, P.

    2014-12-01

    Species distribution models (SDMs) are widely used to study and predict the outcome of global changes on species. In human dominated ecosystems the presence of a given species is the result of both its ecological suitability and human footprint on nature such as land use choices. Land use choices may thus be responsible for a selection bias in the presence/absence data used in SDM calibration. We present a structural modelling approach (i.e. based on structural equation modelling) that accounts for this selection bias. The new structural species distribution model (SSDM) estimates simultaneously land use choices and species responses to bioclimatic variables. A land use equation based on an econometric model of landowner choices was joined to an equation of species response to bioclimatic variables. SSDM allows the residuals of both equations to be dependent, taking into account the possibility of shared omitted variables and measurement errors. We provide a general description of the statistical theory and a set of applications on forest trees over France using databases of climate and forest inventory at different spatial resolution (from 2km to 8km). We also compared the outputs of the SSDM with outputs of a classical SDM (i.e. Biomod ensemble modelling) in terms of bioclimatic response curves and potential distributions under current climate and climate change scenarios. The shapes of the bioclimatic response curves and the modelled species distribution maps differed markedly between SSDM and classical SDMs, with contrasted patterns according to species and spatial resolutions. The magnitude and directions of these differences were dependent on the correlations between the errors from both equations and were highest for higher spatial resolutions. A first conclusion is that the use of classical SDMs can potentially lead to strong miss-estimation of the actual and future probability of presence modelled. Beyond this selection bias, the SSDM we propose represents

  5. Refuse dumps from leaf-cutting ant nests reduce the intensity of above-ground competition among neighboring plants in a Patagonian steppe

    Science.gov (United States)

    Farji-Brener, Alejandro G.; Lescano, María Natalia

    2017-11-01

    In arid environments, the high availability of sunlight due to the scarcity of trees suggests that plant competition take place mainly belowground for water and nutrients. However, the occurrence of soil disturbances that increase nutrient availability and thereby promote plant growth may enhance shoot competition between neighboring plants. We conducted a greenhouse experiment to evaluate the influence of the enriched soil patches generated by the leaf-cutting ant, Acromyrmex lobicornis, on the performance of the alien forb Carduus thoermeri (Asteraceae) under different intraspecific competition scenarios. Our results showed that substrate type and competition scenario affected mainly aboveground plant growth. As expected, plants growing without neighbors and in nutrient-rich ant refuse dumps showed more aboveground biomass than plants growing with neighbors and in nutrient-poor steppe soils. However, aboveground competition was more intense in nutrient-poor substrates: plants under shoot and full competition growing in the nutrient-rich ant refuse dumps showed higher biomass than those growing on steppe soils. Belowground biomass was similar among focal plants growing under different substrate type. Our results support the traditional view that increments in resource availability reduce competition intensity. Moreover, the fact that seedlings in this sunny habitat mainly compete aboveground illustrates how limiting factors may be scale-dependent and change in importance as plants grow.

  6. Neighbor-dependent Ramachandran probability distributions of amino acids developed from a hierarchical Dirichlet process model.

    Directory of Open Access Journals (Sweden)

    Daniel Ting

    2010-04-01

    Full Text Available Distributions of the backbone dihedral angles of proteins have been studied for over 40 years. While many statistical analyses have been presented, only a handful of probability densities are publicly available for use in structure validation and structure prediction methods. The available distributions differ in a number of important ways, which determine their usefulness for various purposes. These include: 1 input data size and criteria for structure inclusion (resolution, R-factor, etc.; 2 filtering of suspect conformations and outliers using B-factors or other features; 3 secondary structure of input data (e.g., whether helix and sheet are included; whether beta turns are included; 4 the method used for determining probability densities ranging from simple histograms to modern nonparametric density estimation; and 5 whether they include nearest neighbor effects on the distribution of conformations in different regions of the Ramachandran map. In this work, Ramachandran probability distributions are presented for residues in protein loops from a high-resolution data set with filtering based on calculated electron densities. Distributions for all 20 amino acids (with cis and trans proline treated separately have been determined, as well as 420 left-neighbor and 420 right-neighbor dependent distributions. The neighbor-independent and neighbor-dependent probability densities have been accurately estimated using Bayesian nonparametric statistical analysis based on the Dirichlet process. In particular, we used hierarchical Dirichlet process priors, which allow sharing of information between densities for a particular residue type and different neighbor residue types. The resulting distributions are tested in a loop modeling benchmark with the program Rosetta, and are shown to improve protein loop conformation prediction significantly. The distributions are available at http://dunbrack.fccc.edu/hdp.

  7. Effects of processing parameters on Be/CuCrZr joining

    International Nuclear Information System (INIS)

    Park, Jeong-Yong; Lee, Jung-Suk; Choi, Byung-Kwon; Park, Sang-Yun; Hong, Bong Guen; Jeong, Yong Hwan; Jung, Ki-Jung

    2007-01-01

    A joining of Be/CuCrZr has been considered as the key technology for the fabrication of the ITER first wall. Among the joining methods, Hot isostatic pressing (HIP), which is one of the diffusion bonding methods, is the most feasible method to join the Be and CuCrZr alloy. In the HIP joining of Be and CuCrZr, the interlayer was used to prevent the formation of brittle intermetallic compounds in the interface. Therefore, it is crucial to select a suitable interlayer for a joining of Be and CuCrZr. On the other hand, the diffusion between Be and CuCrZr would be enhanced with an increase of the HIP joining temperature, thereby increasing the joint strength. However, the HIP joining temperature is limited by the mechanical properties of CuCrZr. During the fabrication process of the ITER first wall, CuCrZr is subjected to several thermal cycles including a solution annealing, a cooling and an aging. The HIP joining of Be and CuCrZr corresponds to the aging of CuCrZr. The HIP joining at a higher temperature would cause a degradation of the mechanical properties of CuCrZr by an overaging effect although it is preferable for an improvement of the joint strength. In this study, the effect of the cooling rate on the mechanical properties of aged CuCrZr was investigated to find the maximum HIP temperature without a degradation of the mechanical properties of CuCrZr

  8. A dumbed-down approach to unite Fermilab, its neighbors

    CERN Multimedia

    Constable, B

    2004-01-01

    "...Fermilab is reaching out to its suburban neighbors...With the nation on orange alert, Fermilab scientists no longer can sit on the front porch and invite neighbors in for coffee and quasars" (1 page).

  9. [Effects of crop tree release on stand growth and stand structure of Cunninghamia lanceolata plantation].

    Science.gov (United States)

    Wu, Jian-qiang; Wang, Yi-xiang; Yang, Yi; Zhu, Ting-ting; Zhu, Xu-dan

    2015-02-01

    Crop trees were selected in a 26-year-old even-aged Cunninghamia lanceolata plantation in Lin' an, and compared in plots that were released and unreleased to examine growth and structure responses for 3 years after thinning. Crop tree release significantly increased the mean increments of diameter and volume of individual tree by 1.30 and 1.25 times relative to trees in control stands, respectively. The increments of diameter and volume of crop trees were significantly higher than those of general trees in thinning plots, crop trees and general trees in control plots, which suggested that the responses from different tree types to crop tree release treatment were different. Crop tree release increased the average distances of crop trees to the nearest neighboring trees, reducing competition among crop trees by about 68.2%. 3-year stand volume increment for thinning stands had no significant difference with that of control stands although the number of trees was only 81.5% of the control. Crop trees in thinned plots with diameters over than 14 cm reached 18.0% over 3 years, compared with 12.0% for trees without thinning, suggesting that crop tree release benefited the larger individual trees. The pattern of tree locations in thinning plots tended to be random, complying with the rule that tree distribution pattern changes with growth. Crop tree release in C. lanceolata plantation not only promoted the stand growth, but also optimized the stand structure, benefiting crop trees sustained rapid growth and larger diameter trees production.

  10. Joining of Tungsten Armor Using Functional Gradients

    International Nuclear Information System (INIS)

    John Scott O'Dell

    2006-01-01

    The joining of low thermal expansion armor materials such as tungsten to high thermal expansion heat sink materials has been a major problem in plasma facing component (PFC) development. Conventional planar bonding techniques have been unable to withstand the high thermal induced stresses resulting from fabrication and high heat flux testing. During this investigation, innovative functional gradient joints produced using vacuum plasma spray forming techniques have been developed for joining tungsten armor to copper alloy heat sinks. A model was developed to select the optimum gradient architecture. Based on the modeling effort, a 2mm copper rich gradient was selected. Vacuum plasma pray parameters and procedures were then developed to produce the functional gradient joint. Using these techniques, dual cooling channel, medium scale mockups (32mm wide x 400mm length) were produced with vacuum plasma spray formed tungsten armor. The thickness of the tungsten armor was up to 5mm thick. No evidence of debonding at the interface between the heat sink and the vacuum plasma sprayed material was observed.

  11. A tree based method for the rapid screening of chemical fingerprints

    DEFF Research Database (Denmark)

    Kristensen, Thomas Greve; Nielsen, Jesper; Pedersen, Christian Nørgaard Storm

    2009-01-01

    The fingerprint of a molecule is a bitstring based on its structure, constructed such that structurally similar molecules will have similar fingerprints. Molecular fingerprints can be used in an initial phase for identifying novel drug candidates by screening large databases for molecules......: the kD grid and the Multibit tree. The kD grid is based on splitting the fingerprints into k shorter bitstrings and utilising these to compute bounds on the similarity of the complete bitstrings. The Multibit tree uses hierarchical clustering and similarity within each cluster to compute similar bounds...

  12. ENTROPY CHARACTERISTICS IN MODELS FOR COORDINATION OF NEIGHBORING ROAD SECTIONS

    Directory of Open Access Journals (Sweden)

    N. I. Kulbashnaya

    2016-01-01

    Full Text Available The paper considers an application of entropy characteristics as criteria to coordinate traffic conditions at neighboring road sections. It has been proved that the entropy characteristics are widely used in the methods that take into account information influence of the environment on drivers and in the mechanisms that create such traffic conditions which ensure preservation of the optimal level of driver’s emotional tension during the drive. Solution of such problem is considered in the aspect of coordination of traffic conditions at neighboring road sections that, in its turn, is directed on exclusion of any driver’s transitional processes. Methodology for coordination of traffic conditions at neighboring road sections is based on the E. V. Gavrilov’s concept on coordination of some parameters of road sections which can be expressed in the entropy characteristics. The paper proposes to execute selection of coordination criteria according to accident rates because while moving along neighboring road sections traffic conditions change drastically that can result in creation of an accident situation. Relative organization of a driver’s perception field and driver’s interaction with the traffic environment has been selected as entropy characteristics. Therefore, the given characteristics are made conditional to the road accidents rate. The investigation results have revealed a strong correlation between the relative organization of the driver’s perception field and the relative organization of the driver’s interaction with the traffic environment and the accident rate. Results of the executed experiment have proved an influence of the accident rate on the investigated entropy characteristics.

  13. Cladistic analysis of Bantu languages: a new tree based on combined lexical and grammatical data

    Science.gov (United States)

    Rexová, Kateřina; Bastin, Yvonne; Frynta, Daniel

    2006-04-01

    The phylogeny of the Bantu languages is reconstructed by application of the cladistic methodology to the combined lexical and grammatical data (87 languages, 144 characters). A maximum parsimony tree and Bayesian analysis supported some previously recognized clades, e.g., that of eastern and southern Bantu languages. Moreover, the results revealed that Bantu languages south and east of the equatorial forest are probably monophyletic. It suggests an unorthodox scenario of Bantu expansion including (after initial radiation in their homelands and neighboring territories) just a single passage through rainforest areas followed by a subsequent divergence into major clades. The likely localization of this divergence is in the area west of the Great Lakes. It conforms to the view that demographic expansion and dispersal throughout the dry-forests and savanna regions of subequatorial Africa was associated with the acquisition of new technologies (iron metallurgy and grain cultivation).

  14. Algorithms for MDC-based multi-locus phylogeny inference: beyond rooted binary gene trees on single alleles.

    Science.gov (United States)

    Yu, Yun; Warnow, Tandy; Nakhleh, Luay

    2011-11-01

    One of the criteria for inferring a species tree from a collection of gene trees, when gene tree incongruence is assumed to be due to incomplete lineage sorting (ILS), is Minimize Deep Coalescence (MDC). Exact algorithms for inferring the species tree from rooted, binary trees under MDC were recently introduced. Nevertheless, in phylogenetic analyses of biological data sets, estimated gene trees may differ from true gene trees, be incompletely resolved, and not necessarily rooted. In this article, we propose new MDC formulations for the cases where the gene trees are unrooted/binary, rooted/non-binary, and unrooted/non-binary. Further, we prove structural theorems that allow us to extend the algorithms for the rooted/binary gene tree case to these cases in a straightforward manner. In addition, we devise MDC-based algorithms for cases when multiple alleles per species may be sampled. We study the performance of these methods in coalescent-based computer simulations.

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

    OpenAIRE

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

  16. TreePics: visualizing trees with pictures

    Directory of Open Access Journals (Sweden)

    Nicolas Puillandre

    2017-09-01

    Full Text Available While many programs are available to edit phylogenetic trees, associating pictures with branch tips in an efficient and automatic way is not an available option. Here, we present TreePics, a standalone software that uses a web browser to visualize phylogenetic trees in Newick format and that associates pictures (typically, pictures of the voucher specimens to the tip of each branch. Pictures are visualized as thumbnails and can be enlarged by a mouse rollover. Further, several pictures can be selected and displayed in a separate window for visual comparison. TreePics works either online or in a full standalone version, where it can display trees with several thousands of pictures (depending on the memory available. We argue that TreePics can be particularly useful in a preliminary stage of research, such as to quickly detect conflicts between a DNA-based phylogenetic tree and morphological variation, that may be due to contamination that needs to be removed prior to final analyses, or the presence of species complexes.

  17. CaO-Al2O3 glass-ceramic as a joining material for SiC based components: A microstructural study of the effect of Si-ion irradiation

    Science.gov (United States)

    Casalegno, Valentina; Kondo, Sosuke; Hinoki, Tatsuya; Salvo, Milena; Czyrska-Filemonowicz, Aleksandra; Moskalewicz, Tomasz; Katoh, Yutai; Ferraris, Monica

    2018-04-01

    The aim of this work was to investigate and discuss the microstructure and interface reaction of a calcia-alumina based glass-ceramic (CA) with SiC. CA has been used for several years as a glass-ceramic for pressure-less joining of SiC based components. In the present work, the crystalline phases in the CA glass-ceramic and at the CA/SiC interface were investigated and the absence of any detectable amorphous phase was assessed. In order to provide a better understanding of the effect of irradiation on the joining material and on the joints, Si ion irradiation was performed both on bulk CA and CA joined SiC. CA glass-ceramic and CA joined SiC were both irradiated with 5.1 MeV Si2+ ions to 3.3 × 1020 ions/m2 at temperatures of 400 and 800 °C at DuET facility, Kyoto University. This corresponds to a damage level of 5 dpa for SiC averaged over the damage range. This paper presents the results of a microstructural analysis of the irradiated samples as well as an evaluation of the dimensional stability of the CA glass-ceramic and its irradiation temperature and/or damage dependence.

  18. Reducing process delays for real-time earthquake parameter estimation - An application of KD tree to large databases for Earthquake Early Warning

    Science.gov (United States)

    Yin, Lucy; Andrews, Jennifer; Heaton, Thomas

    2018-05-01

    Earthquake parameter estimations using nearest neighbor searching among a large database of observations can lead to reliable prediction results. However, in the real-time application of Earthquake Early Warning (EEW) systems, the accurate prediction using a large database is penalized by a significant delay in the processing time. We propose to use a multidimensional binary search tree (KD tree) data structure to organize large seismic databases to reduce the processing time in nearest neighbor search for predictions. We evaluated the performance of KD tree on the Gutenberg Algorithm, a database-searching algorithm for EEW. We constructed an offline test to predict peak ground motions using a database with feature sets of waveform filter-bank characteristics, and compare the results with the observed seismic parameters. We concluded that large database provides more accurate predictions of the ground motion information, such as peak ground acceleration, velocity, and displacement (PGA, PGV, PGD), than source parameters, such as hypocenter distance. Application of the KD tree search to organize the database reduced the average searching process by 85% time cost of the exhaustive method, allowing the method to be feasible for real-time implementation. The algorithm is straightforward and the results will reduce the overall time of warning delivery for EEW.

  19. Probabilistic atlas based labeling of the cerebral vessel tree

    Science.gov (United States)

    Van de Giessen, Martijn; Janssen, Jasper P.; Brouwer, Patrick A.; Reiber, Johan H. C.; Lelieveldt, Boudewijn P. F.; Dijkstra, Jouke

    2015-03-01

    Preoperative imaging of the cerebral vessel tree is essential for planning therapy on intracranial stenoses and aneurysms. Usually, a magnetic resonance angiography (MRA) or computed tomography angiography (CTA) is acquired from which the cerebral vessel tree is segmented. Accurate analysis is helped by the labeling of the cerebral vessels, but labeling is non-trivial due to anatomical topological variability and missing branches due to acquisition issues. In recent literature, labeling the cerebral vasculature around the Circle of Willis has mainly been approached as a graph-based problem. The most successful method, however, requires the definition of all possible permutations of missing vessels, which limits application to subsets of the tree and ignores spatial information about the vessel locations. This research aims to perform labeling using probabilistic atlases that model spatial vessel and label likelihoods. A cerebral vessel tree is aligned to a probabilistic atlas and subsequently each vessel is labeled by computing the maximum label likelihood per segment from label-specific atlases. The proposed method was validated on 25 segmented cerebral vessel trees. Labeling accuracies were close to 100% for large vessels, but dropped to 50-60% for small vessels that were only present in less than 50% of the set. With this work we showed that using solely spatial information of the vessel labels, vessel segments from stable vessels (>50% presence) were reliably classified. This spatial information will form the basis for a future labeling strategy with a very loose topological model.

  20. Pollinator-mediated interactions in experimental arrays vary with neighbor identity.

    Science.gov (United States)

    Ha, Melissa K; Ivey, Christopher T

    2017-02-01

    Local ecological conditions influence the impact of species interactions on evolution and community structure. We investigated whether pollinator-mediated interactions between coflowering plants vary with plant density, coflowering neighbor identity, and flowering season. We conducted a field experiment in which flowering time and floral neighborhood were manipulated in a factorial design. Early- and late-flowering Clarkia unguiculata plants were placed into arrays with C. biloba neighbors, noncongeneric neighbors, additional conspecific plants, or no additional plants as a density control. We compared whole-plant pollen limitation of seed set, pollinator behavior, and pollen deposition among treatments. Interactions mediated by shared pollinators depended on the identity of the neighbor and possibly changed through time, although flowering-season comparisons were compromised by low early-season plant survival. Interactions with conspecific neighbors were likely competitive late in the season. Interactions with C. biloba appeared to involve facilitation or neutral interactions. Interactions with noncongeners were more consistently competitive. The community composition of pollinators varied among treatment combinations. Pollinator-mediated interactions involved competition and likely facilitation, depending on coflowering neighbor. Experimental manipulation helped to reveal context-dependent variation in indirect biotic interactions. © 2017 Botanical Society of America.

  1. An SDN-Based Authentication Mechanism for Securing Neighbor Discovery Protocol in IPv6

    Directory of Open Access Journals (Sweden)

    Yiqin Lu

    2017-01-01

    Full Text Available The Neighbor Discovery Protocol (NDP is one of the main protocols in the Internet Protocol version 6 (IPv6 suite, and it provides many basic functions for the normal operation of IPv6 in a local area network (LAN, such as address autoconfiguration and address resolution. However, it has many vulnerabilities that can be used by malicious nodes to launch attacks, because the NDP messages are easily spoofed without protection. Surrounding this problem, many solutions have been proposed for securing NDP, but these solutions either proposed new protocols that need to be supported by all nodes or built mechanisms that require the cooperation of all nodes, which is inevitable in the traditional distributed networks. Nevertheless, Software-Defined Networking (SDN provides a new perspective to think about protecting NDP. In this paper, we proposed an SDN-based authentication mechanism to verify the identity of NDP packets transmitted in a LAN. Using the centralized control and programmability of SDN, it can effectively prevent the spoofing attacks and other derived attacks based on spoofing. In addition, this mechanism needs no additional protocol supporting or configuration at hosts and routers and does not introduce any dedicated devices.

  2. Joining of Gamma Titanium Aluminides

    National Research Council Canada - National Science Library

    Baeslack, William

    2002-01-01

    .... Although organized and presented by joining process, many of the observations made and relationships developed, particularly those regarding the weldability and welding metallurgy of gamma titanium...

  3. [Early prenatal diagnosis of diprosopic syncephalic joined twins].

    Science.gov (United States)

    Picaud, A; Nlome-Nze, A R; Engongha-Beka, T; Ogowet-Igumu, N

    1990-06-01

    The authors summarize the case of diprosopic syncephalic joined twins diagnosed at 22 weeks of pregnancy by ultrasonography performed because of hydramnios. The rate of separation anomalies of monozygotic twins is assessed by a review of the literature: from 1 to twenty to fifty thousands for joined twins to 1 per cent fifty thousand to fifteen millions for diprosopus. The etiology is the result of a late division of the egg between D12 and D16. Often an encephalic diprosopic joined twins cause elevated levels of maternal serum alpha protein. Early ultrasonography permits to consider a vaginal therapeutic abortion.

  4. Thematic and spatial resolutions affect model-based predictions of tree species distribution.

    Science.gov (United States)

    Liang, Yu; He, Hong S; Fraser, Jacob S; Wu, ZhiWei

    2013-01-01

    Subjective decisions of thematic and spatial resolutions in characterizing environmental heterogeneity may affect the characterizations of spatial pattern and the simulation of occurrence and rate of ecological processes, and in turn, model-based tree species distribution. Thus, this study quantified the importance of thematic and spatial resolutions, and their interaction in predictions of tree species distribution (quantified by species abundance). We investigated how model-predicted species abundances changed and whether tree species with different ecological traits (e.g., seed dispersal distance, competitive capacity) had different responses to varying thematic and spatial resolutions. We used the LANDIS forest landscape model to predict tree species distribution at the landscape scale and designed a series of scenarios with different thematic (different numbers of land types) and spatial resolutions combinations, and then statistically examined the differences of species abundance among these scenarios. Results showed that both thematic and spatial resolutions affected model-based predictions of species distribution, but thematic resolution had a greater effect. Species ecological traits affected the predictions. For species with moderate dispersal distance and relatively abundant seed sources, predicted abundance increased as thematic resolution increased. However, for species with long seeding distance or high shade tolerance, thematic resolution had an inverse effect on predicted abundance. When seed sources and dispersal distance were not limiting, the predicted species abundance increased with spatial resolution and vice versa. Results from this study may provide insights into the choice of thematic and spatial resolutions for model-based predictions of tree species distribution.

  5. Improved Frame Mode Selection for AMR-WB+ Based on Decision Tree

    Science.gov (United States)

    Kim, Jong Kyu; Kim, Nam Soo

    In this letter, we propose a coding mode selection method for the AMR-WB+ audio coder based on a decision tree. In order to reduce computation while maintaining good performance, decision tree classifier is adopted with the closed loop mode selection results as the target classification labels. The size of the decision tree is controlled by pruning, so the proposed method does not increase the memory requirement significantly. Through an evaluation test on a database covering both speech and music materials, the proposed method is found to achieve a much better mode selection accuracy compared with the open loop mode selection module in the AMR-WB+.

  6. Joining NbTi superconductors by ultrasonic welding

    International Nuclear Information System (INIS)

    Hafstrom, J.W.; Killpatrick, D.H.; Niemann, R.C.; Purcell, J.R.; Thresh, H.R.

    1976-01-01

    An important consideration in the design and construction of large, high-field, superconducting magnets is the capability to fabricate reliable, high-strength, low-resistance joints. A process for joining NbTi, copper stabilized, superconducting composites by ultrasonic welding is described. This process yields a joint strength comparable to that of the superconducting composite and a resistivity significantly lower than achieved by conventional soft soldering. The superconducting properties of the composite are not affected by the joining process. Scarfing the joint to maintain a constant conductor cross section does not degrade its electrical or mechanical properties. The application of the ultrasonic joining process, including process control, scarfing, and NDT procedures, in the construction of the superconducting magnet (U.S. SCMS) for the joint U. S. -- Soviet MHD program is described

  7. α-Cut method based importance measure for criticality analysis in fuzzy probability – Based fault tree analysis

    International Nuclear Information System (INIS)

    Purba, Julwan Hendry; Sony Tjahyani, D.T.; Widodo, Surip; Tjahjono, Hendro

    2017-01-01

    Highlights: •FPFTA deals with epistemic uncertainty using fuzzy probability. •Criticality analysis is important for reliability improvement. •An α-cut method based importance measure is proposed for criticality analysis in FPFTA. •The α-cut method based importance measure utilises α-cut multiplication, α-cut subtraction, and area defuzzification technique. •Benchmarking confirm that the proposed method is feasible for criticality analysis in FPFTA. -- Abstract: Fuzzy probability – based fault tree analysis (FPFTA) has been recently developed and proposed to deal with the limitations of conventional fault tree analysis. In FPFTA, reliabilities of basic events, intermediate events and top event are characterized by fuzzy probabilities. Furthermore, the quantification of the FPFTA is based on fuzzy multiplication rule and fuzzy complementation rule to propagate uncertainties from basic event to the top event. Since the objective of the fault tree analysis is to improve the reliability of the system being evaluated, it is necessary to find the weakest path in the system. For this purpose, criticality analysis can be implemented. Various importance measures, which are based on conventional probabilities, have been developed and proposed for criticality analysis in fault tree analysis. However, not one of those importance measures can be applied for criticality analysis in FPFTA, which is based on fuzzy probability. To be fully applied in nuclear power plant probabilistic safety assessment, FPFTA needs to have its corresponding importance measure. The objective of this study is to develop an α-cut method based importance measure to evaluate and rank the importance of basic events for criticality analysis in FPFTA. To demonstrate the applicability of the proposed measure, a case study is performed and its results are then benchmarked to the results generated by the four well known importance measures in conventional fault tree analysis. The results

  8. Diagnostic tools for nearest neighbors techniques when used with satellite imagery

    Science.gov (United States)

    Ronald E. McRoberts

    2009-01-01

    Nearest neighbors techniques are non-parametric approaches to multivariate prediction that are useful for predicting both continuous and categorical forest attribute variables. Although some assumptions underlying nearest neighbor techniques are common to other prediction techniques such as regression, other assumptions are unique to nearest neighbor techniques....

  9. Unwanted Behaviors and Nuisance Behaviors Among Neighbors in a Belgian Community Sample.

    Science.gov (United States)

    Michaux, Emilie; Groenen, Anne; Uzieblo, Katarzyna

    2015-06-30

    Unwanted behaviors between (ex-)intimates have been extensively studied, while those behaviors within other contexts such as neighbors have received much less scientific consideration. Research indicates that residents are likely to encounter problem behaviors from their neighbors. Besides the lack of clarity in the conceptualization of problem behaviors among neighbors, little is known on which types of behaviors characterize neighbor problems. In this study, the occurrence of two types of problem behaviors encountered by neighbors was explored within a Belgian community sample: unwanted behaviors such as threats and neighbor nuisance issues such as noise nuisance. By clearly distinguishing those two types of behaviors, this study aimed at contributing to the conceptualization of neighbor problems. Next, the coping strategies used to deal with the neighbor problems were investigated. Our results indicated that unwanted behaviors were more frequently encountered by residents compared with nuisance problems. Four out of 10 respondents reported both unwanted pursuit behavior and nuisance problems. It was especially unlikely to encounter nuisance problems in isolation of unwanted pursuit behaviors. While different coping styles (avoiding the neighbor, confronting the neighbor, and enlisting help from others) were equally used by the stalked participants, none of them was perceived as being more effective in reducing the stalking behaviors. Strikingly, despite being aware of specialized help services such as community mediation services, only a very small subgroup enlisted this kind of professional help. © The Author(s) 2015.

  10. An Improvement To The k-Nearest Neighbor Classifier For ECG Database

    Science.gov (United States)

    Jaafar, Haryati; Hidayah Ramli, Nur; Nasir, Aimi Salihah Abdul

    2018-03-01

    The k nearest neighbor (kNN) is a non-parametric classifier and has been widely used for pattern classification. However, in practice, the performance of kNN often tends to fail due to the lack of information on how the samples are distributed among them. Moreover, kNN is no longer optimal when the training samples are limited. Another problem observed in kNN is regarding the weighting issues in assigning the class label before classification. Thus, to solve these limitations, a new classifier called Mahalanobis fuzzy k-nearest centroid neighbor (MFkNCN) is proposed in this study. Here, a Mahalanobis distance is applied to avoid the imbalance of samples distribition. Then, a surrounding rule is employed to obtain the nearest centroid neighbor based on the distributions of training samples and its distance to the query point. Consequently, the fuzzy membership function is employed to assign the query point to the class label which is frequently represented by the nearest centroid neighbor Experimental studies from electrocardiogram (ECG) signal is applied in this study. The classification performances are evaluated in two experimental steps i.e. different values of k and different sizes of feature dimensions. Subsequently, a comparative study of kNN, kNCN, FkNN and MFkCNN classifier is conducted to evaluate the performances of the proposed classifier. The results show that the performance of MFkNCN consistently exceeds the kNN, kNCN and FkNN with the best classification rates of 96.5%.

  11. Heart murmur detection based on wavelet transformation and a synergy between artificial neural network and modified neighbor annealing methods.

    Science.gov (United States)

    Eslamizadeh, Gholamhossein; Barati, Ramin

    2017-05-01

    Early recognition of heart disease plays a vital role in saving lives. Heart murmurs are one of the common heart problems. In this study, Artificial Neural Network (ANN) is trained with Modified Neighbor Annealing (MNA) to classify heart cycles into normal and murmur classes. Heart cycles are separated from heart sounds using wavelet transformer. The network inputs are features extracted from individual heart cycles, and two classification outputs. Classification accuracy of the proposed model is compared with five multilayer perceptron trained with Levenberg-Marquardt, Extreme-learning-machine, back-propagation, simulated-annealing, and neighbor-annealing algorithms. It is also compared with a Self-Organizing Map (SOM) ANN. The proposed model is trained and tested using real heart sounds available in the Pascal database to show the applicability of the proposed scheme. Also, a device to record real heart sounds has been developed and used for comparison purposes too. Based on the results of this study, MNA can be used to produce considerable results as a heart cycle classifier. Copyright © 2017 Elsevier B.V. All rights reserved.

  12. Tree Identification. Competency Based Teaching Materials in Horticulture.

    Science.gov (United States)

    Legacy, Jim; And Others

    This competency-based curriculum unit on tree identification is one of five developed for classroom use in teaching the landscape/nursery area of horticulture. The three sections are each divided into teaching content (in a question-and-answer format) and student skills that outline steps and factors for consideration. Topics covered include…

  13. Not seeing the forest for the trees: size of the minimum spanning trees (MSTs) forest and branch significance in MST-based phylogenetic analysis.

    Science.gov (United States)

    Teixeira, Andreia Sofia; Monteiro, Pedro T; Carriço, João A; Ramirez, Mário; Francisco, Alexandre P

    2015-01-01

    Trees, including minimum spanning trees (MSTs), are commonly used in phylogenetic studies. But, for the research community, it may be unclear that the presented tree is just a hypothesis, chosen from among many possible alternatives. In this scenario, it is important to quantify our confidence in both the trees and the branches/edges included in such trees. In this paper, we address this problem for MSTs by introducing a new edge betweenness metric for undirected and weighted graphs. This spanning edge betweenness metric is defined as the fraction of equivalent MSTs where a given edge is present. The metric provides a per edge statistic that is similar to that of the bootstrap approach frequently used in phylogenetics to support the grouping of taxa. We provide methods for the exact computation of this metric based on the well known Kirchhoff's matrix tree theorem. Moreover, we implement and make available a module for the PHYLOViZ software and evaluate the proposed metric concerning both effectiveness and computational performance. Analysis of trees generated using multilocus sequence typing data (MLST) and the goeBURST algorithm revealed that the space of possible MSTs in real data sets is extremely large. Selection of the edge to be represented using bootstrap could lead to unreliable results since alternative edges are present in the same fraction of equivalent MSTs. The choice of the MST to be presented, results from criteria implemented in the algorithm that must be based in biologically plausible models.

  14. Neighbor Rupture Degree of Some Middle Graphs

    Directory of Open Access Journals (Sweden)

    Gökşen BACAK-TURAN

    2017-12-01

    Full Text Available Networks have an important place in our daily lives. Internet networks, electricity networks, water networks, transportation networks, social networks and biological networks are some of the networks we run into every aspects of our lives. A network consists of centers connected by links. A network is represented when centers and connections modelled by vertices and edges, respectively. In consequence of the failure of some centers or connection lines, measurement of the resistance of the network until the communication interrupted is called vulnerability of the network. In this study, neighbor rupture degree which is a parameter that explores the vulnerability values of the resulting graphs due to the failure of some centers of a communication network and its neighboring centers becoming nonfunctional were applied to some middle graphs and neighbor rupture degree of the $M(C_{n},$ $M(P_{n},$ $M(K_{1,n},$ $M(W_{n},$ $M(P_{n}\\times K_{2}$ and $M(C_{n}\\times K_{2}$ have been found.

  15. Inferring species trees from incongruent multi-copy gene trees using the Robinson-Foulds distance

    Science.gov (United States)

    2013-01-01

    Background Constructing species trees from multi-copy gene trees remains a challenging problem in phylogenetics. One difficulty is that the underlying genes can be incongruent due to evolutionary processes such as gene duplication and loss, deep coalescence, or lateral gene transfer. Gene tree estimation errors may further exacerbate the difficulties of species tree estimation. Results We present a new approach for inferring species trees from incongruent multi-copy gene trees that is based on a generalization of the Robinson-Foulds (RF) distance measure to multi-labeled trees (mul-trees). We prove that it is NP-hard to compute the RF distance between two mul-trees; however, it is easy to calculate this distance between a mul-tree and a singly-labeled species tree. Motivated by this, we formulate the RF problem for mul-trees (MulRF) as follows: Given a collection of multi-copy gene trees, find a singly-labeled species tree that minimizes the total RF distance from the input mul-trees. We develop and implement a fast SPR-based heuristic algorithm for the NP-hard MulRF problem. We compare the performance of the MulRF method (available at http://genome.cs.iastate.edu/CBL/MulRF/) with several gene tree parsimony approaches using gene tree simulations that incorporate gene tree error, gene duplications and losses, and/or lateral transfer. The MulRF method produces more accurate species trees than gene tree parsimony approaches. We also demonstrate that the MulRF method infers in minutes a credible plant species tree from a collection of nearly 2,000 gene trees. Conclusions Our new phylogenetic inference method, based on a generalized RF distance, makes it possible to quickly estimate species trees from large genomic data sets. Since the MulRF method, unlike gene tree parsimony, is based on a generic tree distance measure, it is appealing for analyses of genomic data sets, in which many processes such as deep coalescence, recombination, gene duplication and losses as

  16. Applying and Individual-Based Model to Simultaneously Evaluate Net Ecosystem Production and Tree Diameter Increment

    Science.gov (United States)

    Fang, F. J.

    2017-12-01

    Reconciling observations at fundamentally different scales is central in understanding the global carbon cycle. This study investigates a model-based melding of forest inventory data, remote-sensing data and micrometeorological-station data ("flux towers" estimating forest heat, CO2 and H2O fluxes). The individual tree-based model FORCCHN was used to evaluate the tree DBH increment and forest carbon fluxes. These are the first simultaneous simulations of the forest carbon budgets from flux towers and individual-tree growth estimates of forest carbon budgets using the continuous forest inventory data — under circumstances in which both predictions can be tested. Along with the global implications of such findings, this also improves the capacity for forest sustainable management and the comprehensive understanding of forest ecosystems. In forest ecology, diameter at breast height (DBH) of a tree significantly determines an individual tree's cross-sectional sapwood area, its biomass and carbon storage. Evaluation the annual DBH increment (ΔDBH) of an individual tree is central to understanding tree growth and forest ecology. Ecosystem Carbon flux is a consequence of key ecosystem processes in the forest-ecosystem carbon cycle, Gross and Net Primary Production (GPP and NPP, respectively) and Net Ecosystem Respiration (NEP). All of these closely relate with tree DBH changes and tree death. Despite advances in evaluating forest carbon fluxes with flux towers and forest inventories for individual tree ΔDBH, few current ecological models can simultaneously quantify and predict the tree ΔDBH and forest carbon flux.

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

  18. Detecting Structural Metadata with Decision Trees and Transformation-Based Learning

    National Research Council Canada - National Science Library

    Kim, Joungbum; Schwarm, Sarah E; Ostendorf, Mari

    2004-01-01

    .... Specifically, combinations of decision trees and language models are used to predict sentence ends and interruption points and given these events transformation based learning is used to detect edit...

  19. Combination of individual tree detection and area-based approach in imputation of forest variables using airborne laser data

    Science.gov (United States)

    Vastaranta, Mikko; Kankare, Ville; Holopainen, Markus; Yu, Xiaowei; Hyyppä, Juha; Hyyppä, Hannu

    2012-01-01

    The two main approaches to deriving forest variables from laser-scanning data are the statistical area-based approach (ABA) and individual tree detection (ITD). With ITD it is feasible to acquire single tree information, as in field measurements. Here, ITD was used for measuring training data for the ABA. In addition to automatic ITD (ITD auto), we tested a combination of ITD auto and visual interpretation (ITD visual). ITD visual had two stages: in the first, ITD auto was carried out and in the second, the results of the ITD auto were visually corrected by interpreting three-dimensional laser point clouds. The field data comprised 509 circular plots ( r = 10 m) that were divided equally for testing and training. ITD-derived forest variables were used for training the ABA and the accuracies of the k-most similar neighbor ( k-MSN) imputations were evaluated and compared with the ABA trained with traditional measurements. The root-mean-squared error (RMSE) in the mean volume was 24.8%, 25.9%, and 27.2% with the ABA trained with field measurements, ITD auto, and ITD visual, respectively. When ITD methods were applied in acquiring training data, the mean volume, basal area, and basal area-weighted mean diameter were underestimated in the ABA by 2.7-9.2%. This project constituted a pilot study for using ITD measurements as training data for the ABA. Further studies are needed to reduce the bias and to determine the accuracy obtained in imputation of species-specific variables. The method could be applied in areas with sparse road networks or when the costs of fieldwork must be minimized.

  20. ColorTree: a batch customization tool for phylogenic trees.

    Science.gov (United States)

    Chen, Wei-Hua; Lercher, Martin J

    2009-07-31

    Genome sequencing projects and comparative genomics studies typically aim to trace the evolutionary history of large gene sets, often requiring human inspection of hundreds of phylogenetic trees. If trees are checked for compatibility with an explicit null hypothesis (e.g., the monophyly of certain groups), this daunting task is greatly facilitated by an appropriate coloring scheme. In this note, we introduce ColorTree, a simple yet powerful batch customization tool for phylogenic trees. Based on pattern matching rules, ColorTree applies a set of customizations to an input tree file, e.g., coloring labels or branches. The customized trees are saved to an output file, which can then be viewed and further edited by Dendroscope (a freely available tree viewer). ColorTree runs on any Perl installation as a stand-alone command line tool, and its application can thus be easily automated. This way, hundreds of phylogenic trees can be customized for easy visual inspection in a matter of minutes. ColorTree allows efficient and flexible visual customization of large tree sets through the application of a user-supplied configuration file to multiple tree files.

  1. Prediction of Dominant Forest Tree Species Using QuickBird and Environmental Data

    Directory of Open Access Journals (Sweden)

    Azadeh Abdollahnejad

    2017-02-01

    Full Text Available Modelling the spatial distribution of plants is one of the indirect methods for predicting the properties of plants and can be defined based on the relationship between the spatial distribution of vegetation and environmental variables. In this article, we introduce a new method for the spatial prediction of the dominant trees and species, through a combination of environmental and satellite data. Based on the basal area factor (BAF frequency for each tree species in a total of 518 sample plots, the dominant tree species were determined for each plot. Also, topographical maps of primary and secondary properties were prepared using the digital elevation model (DEM. Categories of soil and the climate maps database of the Doctor Bahramnia Forestry Plan were extracted as well. After pre-processing and processing of spectral data, the pixel values at the sample locations in all the independent factors such as spectral and non-spectral data, were extracted. The modelling rates of tree and shrub species diversity using data mining algorithms of 80% of the sampling plots were taken. Assessment of model accuracy was conducted using 20% of samples and evaluation criteria. Random forest (RF, support vector machine (SVM and k-nearest neighbor (k-NN algorithms were used for spatial distribution modelling of dominant species groups using environmental and spectral variables from 80% of the sample plots. Results showed physiographic factors, especially altitude in combination with soil and climate factors as the most important variables in the distribution of species, while the best model was created by the integration of physiographic factors (in combination with soil and climate with an overall accuracy of 63.85%. In addition, the results of the comparison between the algorithms, showed that the RF algorithm was the most accurate in modelling the diversity.

  2. Transition piece for joining together tubular pieces

    International Nuclear Information System (INIS)

    Holko, K.H.

    1981-01-01

    A transition piece for joining together tubular pieces formed respectively from a low alloy or carbon steel and a high temperature alloy containing at least 16% chromium includes a plurality of tubular parts welded together and formed from materials of selected composition with a maximum chromium content difference of 5% between adjacent parts when the chromium content of each part is below 10% and a maximum chromium difference of 7% between adjacent parts when the chromium content of either part is above 10%. The transition parts are also graded as to such characteristics as thermal expansion coefficient. The transition parts at opposite ends of the transition joint have chromium percentages similar to the tubular pieces to which they are to be joined. The parts may be joined by fusion and/or friction welding and parts may be formed by fusion weld deposition. (author)

  3. Diversity of heavy metal resistant bacteria from Kalimas Surabaya: A phylogenetic taxonomy approach

    Science.gov (United States)

    Zulaika, Enny; Utomo, Andry Prio; Prima, Adisya; Alami, Nur Hidayatul; Kuswytasari, Nengah Dwianita; Shovitri, Maya; Sembiring, Langkah

    2017-06-01

    Bacterial resistance to heavy metal is a genetic and physiological adaptation to the environment which contaminated by heavy metal. Kalimas is an important river in Surabaya that is contaminated by some heavy metals and probably as a habitat for heavy metal resistance bacteria. Bacterial resistance to heavy metals are different for each species, and their diversity can be studied by phylogenetic taxonomy approach. Isolates screening was done using nutrient agar which contained 1 mg/L HgCl2, CdCl2 and K2Cr2O7. Bacterial viability were observed by nutrient broth which contained 10 mg/L HgCl2, 30 mg/L CdCl2 and 50 mg/L K2Cr2O7. Isolates that resistant to heavy metal and viable after exposure to heavy metal were identified using 16S rRNA gene marker by Polymerase Chain Reaction (PCR). Phylogenetic tree reconstruction was done by the neighbor-joining algorithm. Genetic assignment showed isolates that resist and viable after exposure of Hg, Cd and Cr are Bacillus S1, SS19 and DA11. Based on BLAST analysis from NCBI gene bank, 16S rRNA sequences, those isolates were similar with the member of Bacillus cereus. Depend on 16S rRNA nucleotide alignment by the neighbor-joining algorithm, Bacillus S1, SS19 and DA11 were belong to Bacillus cereus sensu-lato group.

  4. Study on Cloud Security Based on Trust Spanning Tree Protocol

    Science.gov (United States)

    Lai, Yingxu; Liu, Zenghui; Pan, Qiuyue; Liu, Jing

    2015-09-01

    Attacks executed on Spanning Tree Protocol (STP) expose the weakness of link layer protocols and put the higher layers in jeopardy. Although the problems have been studied for many years and various solutions have been proposed, many security issues remain. To enhance the security and credibility of layer-2 network, we propose a trust-based spanning tree protocol aiming at achieving a higher credibility of LAN switch with a simple and lightweight authentication mechanism. If correctly implemented in each trusted switch, the authentication of trust-based STP can guarantee the credibility of topology information that is announced to other switch in the LAN. To verify the enforcement of the trusted protocol, we present a new trust evaluation method of the STP using a specification-based state model. We implement a prototype of trust-based STP to investigate its practicality. Experiment shows that the trusted protocol can achieve security goals and effectively avoid STP attacks with a lower computation overhead and good convergence performance.

  5. Surface-based geometric modelling using teaching trees for advanced robots

    International Nuclear Information System (INIS)

    Nakamura, Akira; Ogasawara, Tsukasa; Tsukune, Hideo; Oshima, Masaki

    2000-01-01

    Geometric modelling of the environment is important in robot motion planning. Generally, shapes can be stored in a data base, so the elements that need to be decided are positions and orientations. In this paper, surface-based geometric modelling using a teaching tree is proposed. In this modelling, combinations of surfaces are considered in order to decide positions and orientations of objects. The combinations are represented by a depth-first tree, which makes it easy for the operator to select one combination out of several. This method is effective not only in the case when perfect data can be obtained, but also when conditions for measurement of three-dimensional data are unfavorable, which often occur in the environment of a working robot. (author)

  6. Improving medical diagnosis reliability using Boosted C5.0 decision tree empowered by Particle Swarm Optimization.

    Science.gov (United States)

    Pashaei, Elnaz; Ozen, Mustafa; Aydin, Nizamettin

    2015-08-01

    Improving accuracy of supervised classification algorithms in biomedical applications is one of active area of research. In this study, we improve the performance of Particle Swarm Optimization (PSO) combined with C4.5 decision tree (PSO+C4.5) classifier by applying Boosted C5.0 decision tree as the fitness function. To evaluate the effectiveness of our proposed method, it is implemented on 1 microarray dataset and 5 different medical data sets obtained from UCI machine learning databases. Moreover, the results of PSO + Boosted C5.0 implementation are compared to eight well-known benchmark classification methods (PSO+C4.5, support vector machine under the kernel of Radial Basis Function, Classification And Regression Tree (CART), C4.5 decision tree, C5.0 decision tree, Boosted C5.0 decision tree, Naive Bayes and Weighted K-Nearest neighbor). Repeated five-fold cross-validation method was used to justify the performance of classifiers. Experimental results show that our proposed method not only improve the performance of PSO+C4.5 but also obtains higher classification accuracy compared to the other classification methods.

  7. Joining technology—A challenge for the use of SiC components in HTRs

    Energy Technology Data Exchange (ETDEWEB)

    Herrmann, M., E-mail: marion.herrmann@tu-dresden.de; Meisel, P.; Lippmann, W.; Hurtado, A.

    2016-09-15

    The availability of suitable joining technologies is paramount to the further advancement of ceramic components and their use in HTRs. Among other joining technologies, a modified brazing technology using a laser beam for heating the components to be joined has been developed at TU Dresden. The laser-induced heating behavior of the ceramic material is determined by the interactions between the material and the laser beam. This was shown in two different silicon carbide materials (SSiC and SiC{sub f}-reinforced ceramic material) using a diode laser with wavelengths 808 nm and 940 nm. The laser-based technique was illustrated by three different examples: sealing of monolithic SiC with a pin configuration for fuel claddings, sealing of SiC heat pipes with a length of 1 m, and demonstration of the transferability of the laser technique to fiber-reinforced components by means of a SiC{sub f}/SiCN material. Because the covalent bonding of SiC does not allow conventional welding, much research has been devoted to developing alternative filler systems. Glass or glass–ceramic fillers enable the tailoring of properties such as CTE and viscosity. Glasses are thermally stable up to their glass transition temperatures. It was shown that the crystallization of the yttrium aluminosilicate glass composition of the present work allows it to be used at 1050 °C without any significant changes occurring in braze tightness. For the SiC heat pipes with sodium as the working fluid, a sodium-resistant metal braze consisting of Ni–Ti–Si was formed. The long-term resistance of this filler to sodium at 800 °C was proven. The results demonstrate the possibility of using the laser-based joining technique for the joining of different SiC materials as well as for different brazing materials.

  8. Multi-focus image fusion based on area-based standard deviation in dual tree contourlet transform domain

    Science.gov (United States)

    Dong, Min; Dong, Chenghui; Guo, Miao; Wang, Zhe; Mu, Xiaomin

    2018-04-01

    Multiresolution-based methods, such as wavelet and Contourlet are usually used to image fusion. This work presents a new image fusion frame-work by utilizing area-based standard deviation in dual tree Contourlet trans-form domain. Firstly, the pre-registered source images are decomposed with dual tree Contourlet transform; low-pass and high-pass coefficients are obtained. Then, the low-pass bands are fused with weighted average based on area standard deviation rather than the simple "averaging" rule. While the high-pass bands are merged with the "max-absolute' fusion rule. Finally, the modified low-pass and high-pass coefficients are used to reconstruct the final fused image. The major advantage of the proposed fusion method over conventional fusion is the approximately shift invariance and multidirectional selectivity of dual tree Contourlet transform. The proposed method is compared with wavelet- , Contourletbased methods and other the state-of-the art methods on common used multi focus images. Experiments demonstrate that the proposed fusion framework is feasible and effective, and it performs better in both subjective and objective evaluation.

  9. Market-based approaches to tree valuation

    Science.gov (United States)

    Geoffrey H. Donovan; David T. Butry

    2008-01-01

    A recent four-part series in Arborist News outlined different appraisal processes used to value urban trees. The final article in the series described the three generally accepted approaches to tree valuation: the sales comparison approach, the cost approach, and the income capitalization approach. The author, D. Logan Nelson, noted that the sales comparison approach...

  10. Co-Expression of Neighboring Genes in the Zebrafish (Danio rerio Genome

    Directory of Open Access Journals (Sweden)

    Daryi Wang

    2009-08-01

    Full Text Available Neighboring genes in the eukaryotic genome have a tendency to express concurrently, and the proximity of two adjacent genes is often considered a possible explanation for their co-expression behavior. However, the actual contribution of the physical distance between two genes to their co-expression behavior has yet to be defined. To further investigate this issue, we studied the co-expression of neighboring genes in zebrafish, which has a compact genome and has experienced a whole genome duplication event. Our analysis shows that the proportion of highly co-expressed neighboring pairs (Pearson’s correlation coefficient R>0.7 is low (0.24% ~ 0.67%; however, it is still significantly higher than that of random pairs. In particular, the statistical result implies that the co-expression tendency of neighboring pairs is negatively correlated with their physical distance. Our findings therefore suggest that physical distance may play an important role in the co-expression of neighboring genes. Possible mechanisms related to the neighboring genes’ co-expression are also discussed.

  11. Neighborhood diversity of large trees shows independent species patterns in a mixed dipterocarp forest in Sri Lanka.

    Science.gov (United States)

    Punchi-Manage, Ruwan; Wiegand, Thorsten; Wiegand, Kerstin; Getzin, Stephan; Huth, Andreas; Gunatilleke, C V Savitri; Gunatilleke, I A U Nimal

    2015-07-01

    Interactions among neighboring individuals influence plant performance and should create spatial patterns in local community structure. In order to assess the role of large trees in generating spatial patterns in local species richness, we used the individual species-area relationship (ISAR) to evaluate the species richness of trees of different size classes (and dead trees) in circular neighborhoods with varying radius around large trees of different focal species. To reveal signals of species interactions, we compared the ISAR function of the individuals of focal species with that of randomly selected nearby locations. We expected that large trees should strongly affect the community structure of smaller trees in their neighborhood, but that these effects should fade away with increasing size class. Unexpectedly, we found that only few focal species showed signals of species interactions with trees of the different size classes and that this was less likely for less abundant focal species. However, the few and relatively weak departures from independence were consistent with expectations of the effect of competition for space and the dispersal syndrome on spatial patterns. A noisy signal of competition for space found for large trees built up gradually with increasing life stage; it was not yet present for large saplings but detectable for intermediates. Additionally, focal species with animal-dispersed seeds showed higher species richness in their neighborhood than those with gravity- and gyration-dispersed seeds. Our analysis across the entire ontogeny from recruits to large trees supports the hypothesis that stochastic effects dilute deterministic species interactions in highly diverse communities. Stochastic dilution is a consequence of the stochastic geometry of biodiversity in species-rich communities where the identities of the nearest neighbors of a given plant are largely unpredictable. While the outcome of local species interactions is governed for each

  12. Borated stainless steel joining technology. Final report

    International Nuclear Information System (INIS)

    Smith, R.J.

    1994-12-01

    EPRI had continued investigating the application of borated stainless steel products within the US commercial nuclear power industry through participation in a wide range of activities. This effort provides the documentation of the data obtained in the development of the ASTM-A887 Specification preparation effort conducted by Applied Science and Technology and the most recent efforts for the development of joining technologies conducted under a joint effort by EPRI, Carpenter Technologies and Sandia National Laboratory under a US DOE CRADA program. The data presented in this report provides the basis for the ASTM specification which has been previously unpublished by EPRI and the data generated in support of the Joining Technology research effort conducted at Sandia. The results of the Sandia research, although terminated prior to the completion, confirms earlier data that the degradation of material properties in fusion welded borated stainless steels occurs in the heat affected zone of the weld area and not in the base material. The data obtained also supports the conclusion that the degradation of material properties can be overcome by post weld heat treatment which can result in material properties near the original unwelded metal

  13. Fault tree synthesis for software design analysis of PLC based safety-critical systems

    International Nuclear Information System (INIS)

    Koo, S. R.; Cho, C. H.; Seong, P. H.

    2006-01-01

    As a software verification and validation should be performed for the development of PLC based safety-critical systems, a software safety analysis is also considered in line with entire software life cycle. In this paper, we propose a technique of software safety analysis in the design phase. Among various software hazard analysis techniques, fault tree analysis is most widely used for the safety analysis of nuclear power plant systems. Fault tree analysis also has the most intuitive notation and makes both qualitative and quantitative analyses possible. To analyze the design phase more effectively, we propose a technique of fault tree synthesis, along with a universal fault tree template for the architecture modules of nuclear software. Consequently, we can analyze the safety of software on the basis of fault tree synthesis. (authors)

  14. New Sliding Puzzle with Neighbors Swap Motion

    OpenAIRE

    Prihardono, Ariyanto; Kawagoe, Kenichi

    2015-01-01

    The sliding puzzles (15-puzzle, 8-puzzle, 5-puzzle) are known to have 2 kind of puz-zle: solvable puzzle and unsolvable puzzle. In this thesis, we make a new puzzle with only 1 kind of it, solvable puzzle. This new puzzle is made by adopting sliding puzzle with several additional rules from M13 puzzle; the puzzle that is formed form The Mathieu group M13. This puzzle has a movement that called a neighbors swap motion, a rule of movement that enables every neighboring points to swap. This extr...

  15. Use of a mitochondrial COI sequence to identify species of the subtribe Aphidina (Hemiptera, Aphididae

    Directory of Open Access Journals (Sweden)

    Jianfeng WANG

    2011-08-01

    Full Text Available Aphids of the subtribe Aphidina are found mainly in the North Temperate Zone. The relative lack of diagnostic morphological characteristics has obscured the identification of species in this group. However, DNA-based taxonomic methods can clarify species relationships within this group. Sequence variation in a partial segment of the mitochondrial COI gene was highly effective for resolving species relationships within Aphidina. Forty-five species were correctly identified in a neighbor-joining tree. Mean intraspecific sequence divergence was 0.17%, with a range of 0.00% to 1.54%. Mean interspecific divergence within previously recognized genera or morphologically similar species groups was 4.54%, with variation mainly in the range of 3.50% to 8.00%. Possible reasons for anomalous levels of mean nucleotide divergence within or between some taxa are discussed.

  16. Horn clause verification with convex polyhedral abstraction and tree automata-based refinement

    DEFF Research Database (Denmark)

    Kafle, Bishoksan; Gallagher, John Patrick

    2017-01-01

    In this paper we apply tree-automata techniques to refinement of abstract interpretation in Horn clause verification. We go beyond previous work on refining trace abstractions; firstly we handle tree automata rather than string automata and thereby can capture traces in any Horn clause derivations...... underlying the Horn clauses. Experiments using linear constraint problems and the abstract domain of convex polyhedra show that the refinement technique is practical and that iteration of abstract interpretation with tree automata-based refinement solves many challenging Horn clause verification problems. We...... compare the results with other state-of-the-art Horn clause verification tools....

  17. The role of orthography in the semantic activation of neighbors.

    Science.gov (United States)

    Hino, Yasushi; Lupker, Stephen J; Taylor, Tamsen E

    2012-09-01

    There is now considerable evidence that a letter string can activate semantic information appropriate to its orthographic neighbors (e.g., Forster & Hector's, 2002, TURPLE effect). This phenomenon is the focus of the present research. Using Japanese words, we examined whether semantic activation of neighbors is driven directly by orthographic similarity alone or whether there is also a role for phonological similarity. In Experiment 1, using a relatedness judgment task in which a Kanji word-Katakana word pair was presented on each trial, an inhibitory effect was observed when the initial Kanji word was related to an orthographic and phonological neighbor of the Katakana word target but not when the initial Kanji word was related to a phonological but not orthographic neighbor of the Katakana word target. This result suggests that phonology plays little, if any, role in the activation of neighbors' semantics when reading familiar words. In Experiment 2, the targets were transcribed into Hiragana, a script they are typically not written in, requiring readers to engage in phonological coding. In that experiment, inhibitory effects were observed in both conditions. This result indicates that phonologically mediated semantic activation of neighbors will emerge when phonological processing is necessary in order to understand a written word (e.g., when that word is transcribed into an unfamiliar script). PsycINFO Database Record (c) 2012 APA, all rights reserved.

  18. Development of Joining Technologies for the ITER Blanket First Wall

    Energy Technology Data Exchange (ETDEWEB)

    Choi, Byoung Kwon; Jung, Yang Il; Park, Dong Jun; Kim, Hyun Gil; Park, Sang Yoon; Park, Jeong Yong; Jeong, Yong Hwan; Lee, Dong Won; Kim, Suk Kwon [KAERI, Daejeon (Korea, Republic of)

    2011-01-15

    The design of the ITER blanket first wall includes the Beryllium amour tiles joined to CuCrZr heat sink with stainless steel cooling tubes. For the ITER application, the Be/CuCrZr/SS joint was proposed as a first wall material. The joining of Be/CuCrZr as well as CuCrZr/SS was generally carried out by using a hot isostatic pressing (CuC) in many countries. The joining strength for Be/CuCrZr is relatively lower than that for CuCrZr/SS, since we usually forms surface oxides (BeO) and brittle a metallics with Cu. Therefore, the joining technology for the Be/CuCrZr joint has been investigated. Be is apt to adsorb oxygen in an air atmosphere, so we should be etched to eliminate the surface pre-oxide using a chemical solution and Ar ions in a vacuum chamber. Then we is coated with a first was to prevent further oxidation. The kinds of a first we are chosen to be able to enhance the joining strength as inhibiting excessive be diffusion. The performance of the Be/CuCrZr/SS joint used for the ITER first wall is primarily dependent on the joining strength of the Be/CuCrZr interface. The Cr/Cu and Ti/Cr/Cu interlayers enabled the successful joining of be tile to CuCrZr plate. Moreover, ion-beam assisted deposition (IBAD) increased joining strength of the Be/CuCrZr joint mock-ups. IBAD induced the increased packing of depositing atoms, which resulted in denser and more adhesive interlayers. The interlayers formed by IBAD process revealed about 40% improved resistance to the scratch test. It is suggested that the improved adhesion of coating interlayers enabled tight joining of Be and CuCrZr blocks. As compared to without IBAD coating, the shear strength as well as the 4-point bend strength were increased more than 20% depending on interlayer types and coating conditions

  19. Development of Joining Technologies for the ITER Blanket First Wall

    International Nuclear Information System (INIS)

    Choi, Byoung Kwon; Jung, Yang Il; Park, Dong Jun; Kim, Hyun Gil; Park, Sang Yoon; Park, Jeong Yong; Jeong, Yong Hwan; Lee, Dong Won; Kim, Suk Kwon

    2011-01-01

    The design of the ITER blanket first wall includes the Beryllium amour tiles joined to CuCrZr heat sink with stainless steel cooling tubes. For the ITER application, the Be/CuCrZr/SS joint was proposed as a first wall material. The joining of Be/CuCrZr as well as CuCrZr/SS was generally carried out by using a hot isostatic pressing (CuC) in many countries. The joining strength for Be/CuCrZr is relatively lower than that for CuCrZr/SS, since we usually forms surface oxides (BeO) and brittle a metallics with Cu. Therefore, the joining technology for the Be/CuCrZr joint has been investigated. Be is apt to adsorb oxygen in an air atmosphere, so we should be etched to eliminate the surface pre-oxide using a chemical solution and Ar ions in a vacuum chamber. Then we is coated with a first was to prevent further oxidation. The kinds of a first we are chosen to be able to enhance the joining strength as inhibiting excessive be diffusion. The performance of the Be/CuCrZr/SS joint used for the ITER first wall is primarily dependent on the joining strength of the Be/CuCrZr interface. The Cr/Cu and Ti/Cr/Cu interlayers enabled the successful joining of be tile to CuCrZr plate. Moreover, ion-beam assisted deposition (IBAD) increased joining strength of the Be/CuCrZr joint mock-ups. IBAD induced the increased packing of depositing atoms, which resulted in denser and more adhesive interlayers. The interlayers formed by IBAD process revealed about 40% improved resistance to the scratch test. It is suggested that the improved adhesion of coating interlayers enabled tight joining of Be and CuCrZr blocks. As compared to without IBAD coating, the shear strength as well as the 4-point bend strength were increased more than 20% depending on interlayer types and coating conditions

  20. Inference of Large Phylogenies Using Neighbour-Joining

    DEFF Research Database (Denmark)

    Simonsen, Martin; Mailund, Thomas; Pedersen, Christian Nørgaard Storm

    2011-01-01

    The neighbour-joining method is a widely used method for phylogenetic reconstruction which scales to thousands of taxa. However, advances in sequencing technology have made data sets with more than 10,000 related taxa widely available. Inference of such large phylogenies takes hours or days using...... the Neighbour-Joining method on a normal desktop computer because of the O(n^3) running time. RapidNJ is a search heuristic which reduce the running time of the Neighbour-Joining method significantly but at the cost of an increased memory consumption making inference of large phylogenies infeasible. We present...... two extensions for RapidNJ which reduce the memory requirements and \\makebox{allows} phylogenies with more than 50,000 taxa to be inferred efficiently on a desktop computer. Furthermore, an improved version of the search heuristic is presented which reduces the running time of RapidNJ on many data...

  1. GSHR-Tree: a spatial index tree based on dynamic spatial slot and hash table in grid environments

    Science.gov (United States)

    Chen, Zhanlong; Wu, Xin-cai; Wu, Liang

    2008-12-01

    Computation Grids enable the coordinated sharing of large-scale distributed heterogeneous computing resources that can be used to solve computationally intensive problems in science, engineering, and commerce. Grid spatial applications are made possible by high-speed networks and a new generation of Grid middleware that resides between networks and traditional GIS applications. The integration of the multi-sources and heterogeneous spatial information and the management of the distributed spatial resources and the sharing and cooperative of the spatial data and Grid services are the key problems to resolve in the development of the Grid GIS. The performance of the spatial index mechanism is the key technology of the Grid GIS and spatial database affects the holistic performance of the GIS in Grid Environments. In order to improve the efficiency of parallel processing of a spatial mass data under the distributed parallel computing grid environment, this paper presents a new grid slot hash parallel spatial index GSHR-Tree structure established in the parallel spatial indexing mechanism. Based on the hash table and dynamic spatial slot, this paper has improved the structure of the classical parallel R tree index. The GSHR-Tree index makes full use of the good qualities of R-Tree and hash data structure. This paper has constructed a new parallel spatial index that can meet the needs of parallel grid computing about the magnanimous spatial data in the distributed network. This arithmetic splits space in to multi-slots by multiplying and reverting and maps these slots to sites in distributed and parallel system. Each sites constructs the spatial objects in its spatial slot into an R tree. On the basis of this tree structure, the index data was distributed among multiple nodes in the grid networks by using large node R-tree method. The unbalance during process can be quickly adjusted by means of a dynamical adjusting algorithm. This tree structure has considered the

  2. An RFID Indoor Positioning Algorithm Based on Bayesian Probability and K-Nearest Neighbor.

    Science.gov (United States)

    Xu, He; Ding, Ye; Li, Peng; Wang, Ruchuan; Li, Yizhu

    2017-08-05

    The Global Positioning System (GPS) is widely used in outdoor environmental positioning. However, GPS cannot support indoor positioning because there is no signal for positioning in an indoor environment. Nowadays, there are many situations which require indoor positioning, such as searching for a book in a library, looking for luggage in an airport, emergence navigation for fire alarms, robot location, etc. Many technologies, such as ultrasonic, sensors, Bluetooth, WiFi, magnetic field, Radio Frequency Identification (RFID), etc., are used to perform indoor positioning. Compared with other technologies, RFID used in indoor positioning is more cost and energy efficient. The Traditional RFID indoor positioning algorithm LANDMARC utilizes a Received Signal Strength (RSS) indicator to track objects. However, the RSS value is easily affected by environmental noise and other interference. In this paper, our purpose is to reduce the location fluctuation and error caused by multipath and environmental interference in LANDMARC. We propose a novel indoor positioning algorithm based on Bayesian probability and K -Nearest Neighbor (BKNN). The experimental results show that the Gaussian filter can filter some abnormal RSS values. The proposed BKNN algorithm has the smallest location error compared with the Gaussian-based algorithm, LANDMARC and an improved KNN algorithm. The average error in location estimation is about 15 cm using our method.

  3. Use of Friction Stir Welding and Friction Stir Processing for Advanced Nuclear Fuels and Materials Joining Applications

    International Nuclear Information System (INIS)

    J. I. Cole; J. F. Jue

    2006-01-01

    Application of the latest developments in materials technology may greatly aid in the successful pursuit of next generation reactor and transmutation technologies. One such area where significant progress is needed is joining of advanced fuels and materials. Rotary friction welding, also referred to as friction stir welding (FSW), has shown great promise as a method for joining traditionally difficult to join materials such as aluminum alloys. This relatively new technology, first developed in 1991, has more recently been applied to higher melting temperature alloys such as steels, nickel-based and titanium alloys. An overview of the FSW technology is provided and two specific nuclear fuels and materials applications where the technique may be used to overcome limitations of conventional joining technologies are highlighted

  4. The Probabilistic Convolution Tree: Efficient Exact Bayesian Inference for Faster LC-MS/MS Protein Inference

    Science.gov (United States)

    Serang, Oliver

    2014-01-01

    Exact Bayesian inference can sometimes be performed efficiently for special cases where a function has commutative and associative symmetry of its inputs (called “causal independence”). For this reason, it is desirable to exploit such symmetry on big data sets. Here we present a method to exploit a general form of this symmetry on probabilistic adder nodes by transforming those probabilistic adder nodes into a probabilistic convolution tree with which dynamic programming computes exact probabilities. A substantial speedup is demonstrated using an illustration example that can arise when identifying splice forms with bottom-up mass spectrometry-based proteomics. On this example, even state-of-the-art exact inference algorithms require a runtime more than exponential in the number of splice forms considered. By using the probabilistic convolution tree, we reduce the runtime to and the space to where is the number of variables joined by an additive or cardinal operator. This approach, which can also be used with junction tree inference, is applicable to graphs with arbitrary dependency on counting variables or cardinalities and can be used on diverse problems and fields like forward error correcting codes, elemental decomposition, and spectral demixing. The approach also trivially generalizes to multiple dimensions. PMID:24626234

  5. Direct and indirect effects of a dense understory on tree seedling recruitment in temperate forests: habitat-mediated predation versus competition

    Science.gov (United States)

    Alejandro A. Royo; Walter P. Carson

    2008-01-01

    In forests characterized by a dense woody and herbaceous understory layer, seedling recruitment is often directly suppressed via interspecific competition. Alternatively, these dense layers may indirectly lower tree recruitment by providing a haven for seed and seedling predators that prey on neighboring plant species. To simultaneously...

  6. Temperature Effect on Electrical Treeing and Partial Discharge Characteristics of Silicone Rubber-Based Nanocomposites

    Directory of Open Access Journals (Sweden)

    Mohd Hafizi Ahmad

    2015-01-01

    Full Text Available This study investigated electrical treeing and its associated phase-resolved partial discharge (PD activities in room-temperature, vulcanized silicone rubber/organomontmorillonite nanocomposite sample materials over a range of temperatures in order to assess the effect of temperature on different filler concentrations under AC voltage. The samples were prepared with three levels of nanofiller content: 0% by weight (wt, 1% by wt, and 3% by wt. The electrical treeing and PD activities of these samples were investigated at temperatures of 20°C, 40°C, and 60°C. The results show that the characteristics of the electrical tree changed with increasing temperature. The tree inception times decreased at 20°C due to space charge dynamics, and the tree growth time increased at 40°C due to the increase in the number of cross-link network structures caused by the vulcanization process. At 60°C, more enhanced and reinforced properties of the silicone rubber-based nanocomposite samples occurred. This led to an increase in electrical tree inception time and electrical tree growth time. However, the PD characteristics, particularly the mean phase angle of occurrence of the positive and negative discharge distributions, were insensitive to variations in temperature. This reflects an enhanced stability in the nanocomposite electrical properties compared with the base polymer.

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

  8. DNA barcoding and phylogeny of Calidris and Tringa (Aves: Scolopacidae).

    Science.gov (United States)

    Huang, Zuhao; Tu, Feiyun

    2017-07-01

    The avian genera Calidris and Tringa are the largest of the widespread family of Scolopacidae. The phylogeny of members of the two genera is still a matter of controversial. Mitochondrial cytochrome c oxidase subunit I (COI) can serve as a fast and accurate marker for the identification and phylogeny of animal species. In this study, we analyzed the COI barcodes of thirty-one species of the two genera. All the species had distinct COI sequences. Two hundred and twenty-one variable sites were identified. Kimura two-parameter distances were calculated between barcodes. Neighbor-joining and maximum likelihood methods were used to construct phylogenetic trees. All the species could be discriminated by their distinct clades in the phylogenetic trees. The phylogenetic trees grouped all the species of Calidris and Tringa into different monophyletic clade, respectively. COI data showed a well-supported phylogeny for Calidris and Tringa species.

  9. Effect of epoxy resin on bending momentum in L type corner joins

    Directory of Open Access Journals (Sweden)

    Mehmet Nuri Yıldırım

    2017-11-01

    Full Text Available In the furniture industry, the joining points of frame and box construction furniture according to the loads to be affected by the use place is important for the security of the user and service life of the furniture element. In this direction, it is aimed to determine the diagonal compression and diagonal tensile moment values of "L" type corner joints of box framed construction furniture prepared from solid wood materials. The Pinus Nigra, Fagus Orientalis L and Populus Nigra were used as solid wood materials. Wood-based biscuit joining elements were used in corner joints of the test construction and epoxy resin was used as glue for materials. The static loads were applied to construction according to ASTM-D1037. The results show that, the highest tensile and compression values were obtained from Fagus Orientalis L and the lowest values were obtained from Populus Nigra specimens. In the statistical study, the difference between the tensile and compressive bending moment values of the biscuit connection element was found to be statistically significant. This study indicates that, it is suggested to use of L type joints prepared from Fagus Orientalis L by using epoxy resin and wood based biscuit joining element in frame constructions.

  10. Semi-Automatic Anatomical Tree Matching for Landmark-Based Elastic Registration of Liver Volumes

    Directory of Open Access Journals (Sweden)

    Klaus Drechsler

    2010-01-01

    Full Text Available One promising approach to register liver volume acquisitions is based on the branching points of the vessel trees as anatomical landmarks inherently available in the liver. Automated tree matching algorithms were proposed to automatically find pair-wise correspondences between two vessel trees. However, to the best of our knowledge, none of the existing automatic methods are completely error free. After a review of current literature and methodologies on the topic, we propose an efficient interaction method that can be employed to support tree matching algorithms with important pre-selected correspondences or after an automatic matching to manually correct wrongly matched nodes. We used this method in combination with a promising automatic tree matching algorithm also presented in this work. The proposed method was evaluated by 4 participants and a CT dataset that we used to derive multiple artificial datasets.

  11. Improvement of testing and maintenance based on fault tree analysis

    International Nuclear Information System (INIS)

    Cepin, M.

    2000-01-01

    Testing and maintenance of safety equipment is an important issue, which significantly contributes to safe and efficient operation of a nuclear power plant. In this paper a method, which extends the classical fault tree with time, is presented. Its mathematical model is represented by a set of equations, which include time requirements defined in the house event matrix. House events matrix is a representation of house events switched on and off through the discrete points of time. It includes house events, which timely switch on and off parts of the fault tree in accordance with the status of the plant configuration. Time dependent top event probability is calculated by the fault tree evaluations. Arrangement of components outages is determined on base of minimization of mean system unavailability. The results show that application of the method may improve the time placement of testing and maintenance activities of safety equipment. (author)

  12. Credibilistic multi-period portfolio optimization based on scenario tree

    Science.gov (United States)

    Mohebbi, Negin; Najafi, Amir Abbas

    2018-02-01

    In this paper, we consider a multi-period fuzzy portfolio optimization model with considering transaction costs and the possibility of risk-free investment. We formulate a bi-objective mean-VaR portfolio selection model based on the integration of fuzzy credibility theory and scenario tree in order to dealing with the markets uncertainty. The scenario tree is also a proper method for modeling multi-period portfolio problems since the length and continuity of their horizon. We take the return and risk as well cardinality, threshold, class, and liquidity constraints into consideration for further compliance of the model with reality. Then, an interactive dynamic programming method, which is based on a two-phase fuzzy interactive approach, is employed to solve the proposed model. In order to verify the proposed model, we present an empirical application in NYSE under different circumstances. The results show that the consideration of data uncertainty and other real-world assumptions lead to more practical and efficient solutions.

  13. An Assessment of the Effectiveness of Tree-Based Models for Multi-Variate Flood Damage Assessment in Australia

    Directory of Open Access Journals (Sweden)

    Roozbeh Hasanzadeh Nafari

    2016-07-01

    Full Text Available Flood is a frequent natural hazard that has significant financial consequences for Australia. In Australia, physical losses caused by floods are commonly estimated by stage-damage functions. These methods usually consider only the depth of the water and the type of buildings at risk. However, flood damage is a complicated process, and it is dependent on a variety of factors which are rarely taken into account. This study explores the interaction, importance, and influence of water depth, flow velocity, water contamination, precautionary measures, emergency measures, flood experience, floor area, building value, building quality, and socioeconomic status. The study uses tree-based models (regression trees and bagging decision trees and a dataset collected from 2012 to 2013 flood events in Queensland, which includes information on structural damages, impact parameters, and resistance variables. The tree-based approaches show water depth, floor area, precautionary measures, building value, and building quality to be important damage-influencing parameters. Furthermore, the performance of the tree-based models is validated and contrasted with the outcomes of a multi-parameter loss function (FLFArs from Australia. The tree-based models are shown to be more accurate than the stage-damage function. Consequently, considering more parameters and taking advantage of tree-based models is recommended. The outcome is important for improving established Australian flood loss models and assisting decision-makers and insurance companies dealing with flood risk assessment.

  14. An object-based approach for tree species extraction from digital orthophoto maps

    Science.gov (United States)

    Jamil, Akhtar; Bayram, Bulent

    2018-05-01

    Tree segmentation is an active and ongoing research area in the field of photogrammetry and remote sensing. It is more challenging due to both intra-class and inter-class similarities among various tree species. In this study, we exploited various statistical features for extraction of hazelnut trees from 1 : 5000 scaled digital orthophoto maps. Initially, the non-vegetation areas were eliminated using traditional normalized difference vegetation index (NDVI) followed by application of mean shift segmentation for transforming the pixels into meaningful homogeneous objects. In order to eliminate false positives, morphological opening and closing was employed on candidate objects. A number of heuristics were also derived to eliminate unwanted effects such as shadow and bounding box aspect ratios, before passing them into the classification stage. Finally, a knowledge based decision tree was constructed to distinguish the hazelnut trees from rest of objects which include manmade objects and other type of vegetation. We evaluated the proposed methodology on 10 sample orthophoto maps obtained from Giresun province in Turkey. The manually digitized hazelnut tree boundaries were taken as reference data for accuracy assessment. Both manually digitized and segmented tree borders were converted into binary images and the differences were calculated. According to the obtained results, the proposed methodology obtained an overall accuracy of more than 85 % for all sample images.

  15. Predicting volume of distribution with decision tree-based regression methods using predicted tissue:plasma partition coefficients.

    Science.gov (United States)

    Freitas, Alex A; Limbu, Kriti; Ghafourian, Taravat

    2015-01-01

    Volume of distribution is an important pharmacokinetic property that indicates the extent of a drug's distribution in the body tissues. This paper addresses the problem of how to estimate the apparent volume of distribution at steady state (Vss) of chemical compounds in the human body using decision tree-based regression methods from the area of data mining (or machine learning). Hence, the pros and cons of several different types of decision tree-based regression methods have been discussed. The regression methods predict Vss using, as predictive features, both the compounds' molecular descriptors and the compounds' tissue:plasma partition coefficients (Kt:p) - often used in physiologically-based pharmacokinetics. Therefore, this work has assessed whether the data mining-based prediction of Vss can be made more accurate by using as input not only the compounds' molecular descriptors but also (a subset of) their predicted Kt:p values. Comparison of the models that used only molecular descriptors, in particular, the Bagging decision tree (mean fold error of 2.33), with those employing predicted Kt:p values in addition to the molecular descriptors, such as the Bagging decision tree using adipose Kt:p (mean fold error of 2.29), indicated that the use of predicted Kt:p values as descriptors may be beneficial for accurate prediction of Vss using decision trees if prior feature selection is applied. Decision tree based models presented in this work have an accuracy that is reasonable and similar to the accuracy of reported Vss inter-species extrapolations in the literature. The estimation of Vss for new compounds in drug discovery will benefit from methods that are able to integrate large and varied sources of data and flexible non-linear data mining methods such as decision trees, which can produce interpretable models. Graphical AbstractDecision trees for the prediction of tissue partition coefficient and volume of distribution of drugs.

  16. Influence of cerrado fragments in the distribution of mites in rubber tree crop; Influencia de fragmentos de cerrado na distribuicao de acaros em seringal

    Energy Technology Data Exchange (ETDEWEB)

    Demite, Peterson R. [UNESP, Sao Jose do Rio Preto, SP (Brazil). Programa de Pos-graduacao em Biologia Animal; Plantacoes E. Michelin Ltda., Itiquira, MT (Brazil)]. E-mail: peterson_demite@yahoo.com.br; Feres, Reinaldo J.F. [UNESP, Sao Jose do Rio Preto, SP (Brazil). Dept. de Zoologia e Botanica]. E-mail: reinaldo@ibilce.unesp.br

    2008-03-15

    The aim of this study was to verify whether fragments of cerrado influence the composition of the mite fauna on rubber trees. Five transects distant 50 m, being the first in the edge near the native areas and the last 200 m inside the crop, were established in each rubber tree crop in southern State of Mato Grosso. In each transect five plants were chosen, and seven leaves were collected from each plant. During one year, 25 quantitative samplings were conducted in two rubber tree crops. The lowest number of phytophagous mites occurred in the transect closer to the native vegetation, and the highest number, in the most distant from the native vegetation. The largest diversity was also observed in the transect closer to the neighboring vegetation. Ten species of predatory mites were also registered in neighboring native areas. These data suggest the movement of predatory mites from the native areas to the mono culture. These natural areas can possibly supply alternative food and habitat for natural enemies of phytophagous mites in the period of food scarceness in the rubber tree crop. The presence of native areas close to culture areas should be taken into account in the elaboration of programs of ecological management of pests. (author)

  17. Applied Swarm-based medicine: collecting decision trees for patterns of algorithms analysis.

    Science.gov (United States)

    Panje, Cédric M; Glatzer, Markus; von Rappard, Joscha; Rothermundt, Christian; Hundsberger, Thomas; Zumstein, Valentin; Plasswilm, Ludwig; Putora, Paul Martin

    2017-08-16

    The objective consensus methodology has recently been applied in consensus finding in several studies on medical decision-making among clinical experts or guidelines. The main advantages of this method are an automated analysis and comparison of treatment algorithms of the participating centers which can be performed anonymously. Based on the experience from completed consensus analyses, the main steps for the successful implementation of the objective consensus methodology were identified and discussed among the main investigators. The following steps for the successful collection and conversion of decision trees were identified and defined in detail: problem definition, population selection, draft input collection, tree conversion, criteria adaptation, problem re-evaluation, results distribution and refinement, tree finalisation, and analysis. This manuscript provides information on the main steps for successful collection of decision trees and summarizes important aspects at each point of the analysis.

  18. Mapping DNA methylation by transverse current sequencing: Reduction of noise from neighboring nucleotides

    Science.gov (United States)

    Alvarez, Jose; Massey, Steven; Kalitsov, Alan; Velev, Julian

    Nanopore sequencing via transverse current has emerged as a competitive candidate for mapping DNA methylation without needed bisulfite-treatment, fluorescent tag, or PCR amplification. By eliminating the error producing amplification step, long read lengths become feasible, which greatly simplifies the assembly process and reduces the time and the cost inherent in current technologies. However, due to the large error rates of nanopore sequencing, single base resolution has not been reached. A very important source of noise is the intrinsic structural noise in the electric signature of the nucleotide arising from the influence of neighboring nucleotides. In this work we perform calculations of the tunneling current through DNA molecules in nanopores using the non-equilibrium electron transport method within an effective multi-orbital tight-binding model derived from first-principles calculations. We develop a base-calling algorithm accounting for the correlations of the current through neighboring bases, which in principle can reduce the error rate below any desired precision. Using this method we show that we can clearly distinguish DNA methylation and other base modifications based on the reading of the tunneling current.

  19. Accounting for selection bias in species distribution models: An econometric approach on forested trees based on structural modeling

    Science.gov (United States)

    Ay, Jean-Sauveur; Guillemot, Joannès; Martin-StPaul, Nicolas K.; Doyen, Luc; Leadley, Paul

    2015-04-01

    Species distribution models (SDMs) are widely used to study and predict the outcome of global change on species. In human dominated ecosystems the presence of a given species is the result of both its ecological suitability and human footprint on nature such as land use choices. Land use choices may thus be responsible for a selection bias in the presence/absence data used in SDM calibration. We present a structural modelling approach (i.e. based on structural equation modelling) that accounts for this selection bias. The new structural species distribution model (SSDM) estimates simultaneously land use choices and species responses to bioclimatic variables. A land use equation based on an econometric model of landowner choices was joined to an equation of species response to bioclimatic variables. SSDM allows the residuals of both equations to be dependent, taking into account the possibility of shared omitted variables and measurement errors. We provide a general description of the statistical theory and a set of application on forested trees over France using databases of climate and forest inventory at different spatial resolution (from 2km to 8 km). We also compared the output of the SSDM with outputs of a classical SDM in term of bioclimatic response curves and potential distribution under current climate. According to the species and the spatial resolution of the calibration dataset, shapes of bioclimatic response curves the modelled species distribution maps differed markedly between the SSDM and classical SDMs. The magnitude and directions of these differences were dependent on the correlations between the errors from both equations and were highest for higher spatial resolutions. A first conclusion is that the use of classical SDMs can potentially lead to strong miss-estimation of the actual and future probability of presence modelled. Beyond this selection bias, the SSDM we propose represents a crucial step to account for economic constraints on tree

  20. Nonhomologous DNA End Joining in Cell-Free Extracts

    Directory of Open Access Journals (Sweden)

    Sheetal Sharma

    2010-01-01

    Full Text Available Among various DNA damages, double-strand breaks (DSBs are considered as most deleterious, as they may lead to chromosomal rearrangements and cancer when unrepaired. Nonhomologous DNA end joining (NHEJ is one of the major DSB repair pathways in higher organisms. A large number of studies on NHEJ are based on in vitro systems using cell-free extracts. In this paper, we summarize the studies on NHEJ performed by various groups in different cell-free repair systems.

  1. Computer aided process planning system based on workflow technology and integrated bill of material tree

    Institute of Scientific and Technical Information of China (English)

    LU Chun-guang; MENG Li-li

    2006-01-01

    It is extremely important for procedure of process design and management of process data for product life cycle in Computer Aided Process Planning (CAPP) system,but there are many shortcomings with traditional CAPP system in these respects.To solve these questions,application of workflow technology in CAPP system based on web-integrated Bill of Material (BOM) tree is discussed,and a concept of integrated BOM tree was brought forward.Taking integrated BOM as the thread,CAPP systematic technological process is analyzed.The function,system architecture,and implementation mechanism of CAPP system based on Browser/Server and Customer/Server model are expatiated.Based on it,the key technologies of workflow management device were analyzed.Eventually,the implementation mechanism of integrated BOM tree was analyzed from viewpoints of material information encoding,organization node design of integrated BOM tree,transformation from Engineering BOM (EBOM)to Process BOM (PBOM),and the programming implementation technology.

  2. Effects of tree-to-tree variations on sap flux-based transpiration estimates in a forested watershed

    Science.gov (United States)

    Kume, Tomonori; Tsuruta, Kenji; Komatsu, Hikaru; Kumagai, Tomo'omi; Higashi, Naoko; Shinohara, Yoshinori; Otsuki, Kyoichi

    2010-05-01

    To estimate forest stand-scale water use, we assessed how sample sizes affect confidence of stand-scale transpiration (E) estimates calculated from sap flux (Fd) and sapwood area (AS_tree) measurements of individual trees. In a Japanese cypress plantation, we measured Fd and AS_tree in all trees (n = 58) within a 20 × 20 m study plot, which was divided into four 10 × 10 subplots. We calculated E from stand AS_tree (AS_stand) and mean stand Fd (JS) values. Using Monte Carlo analyses, we examined potential errors associated with sample sizes in E, AS_stand, and JS by using the original AS_tree and Fd data sets. Consequently, we defined optimal sample sizes of 10 and 15 for AS_stand and JS estimates, respectively, in the 20 × 20 m plot. Sample sizes greater than the optimal sample sizes did not decrease potential errors. The optimal sample sizes for JS changed according to plot size (e.g., 10 × 10 m and 10 × 20 m), while the optimal sample sizes for AS_stand did not. As well, the optimal sample sizes for JS did not change in different vapor pressure deficit conditions. In terms of E estimates, these results suggest that the tree-to-tree variations in Fd vary among different plots, and that plot size to capture tree-to-tree variations in Fd is an important factor. This study also discusses planning balanced sampling designs to extrapolate stand-scale estimates to catchment-scale estimates.

  3. Color and neighbor edge directional difference feature for image retrieval

    Institute of Scientific and Technical Information of China (English)

    Chaobing Huang; Shengsheng Yu; Jingli Zhou; Hongwei Lu

    2005-01-01

    @@ A novel image feature termed neighbor edge directional difference unit histogram is proposed, in which the neighbor edge directional difference unit is defined and computed for every pixel in the image, and is used to generate the neighbor edge directional difference unit histogram. This histogram and color histogram are used as feature indexes to retrieve color image. The feature is invariant to image scaling and translation and has more powerful descriptive for the natural color images. Experimental results show that the feature can achieve better retrieval performance than other color-spatial features.

  4. A Voronoi interior adjacency-based approach for generating a contour tree

    Science.gov (United States)

    Chen, Jun; Qiao, Chaofei; Zhao, Renliang

    2004-05-01

    A contour tree is a good graphical tool for representing the spatial relations of contour lines and has found many applications in map generalization, map annotation, terrain analysis, etc. A new approach for generating contour trees by introducing a Voronoi-based interior adjacency set concept is proposed in this paper. The immediate interior adjacency set is employed to identify all of the children contours of each contour without contour elevations. It has advantages over existing methods such as the point-in-polygon method and the region growing-based method. This new approach can be used for spatial data mining and knowledge discovering, such as the automatic extraction of terrain features and construction of multi-resolution digital elevation model.

  5. Joining of thin thickness SiCf/SiC composites: research of a joining composition and of an associated elaboration process

    International Nuclear Information System (INIS)

    Jacques, E.

    2012-01-01

    The present work is part of the Fourth Generation Fast Reactors program. One of the key issues is the joining of the SiC f /SiC ceramic matrix composites (CMC) to seal the combustible cladding. At the present time, no chemical composition as a joint is refractive enough to face the expected operating temperatures. The aims of this study are the following: (1) the identification of a joining composition and its associated elaboration process answering the specifications, (2) the validation of a local and fast heating process and (3) the definition of mechanical tests to characterise these joinings. We describe the methodology and the results for joining SiC and SiC f /SiC substrates at solid and liquid state using metallic silicides. Joint integrity and joint strength can be improved by adding small SiC particles to the silicides powders. Chemical reactivity, wettability tests and thermomechanical properties analysis have been carried out on the joints. Cross sections of the assembly were prepared to study the joint/substrate chemical bonding, the cracking and the crack deflection in the vicinity of the interface. Also, one of the challenge consists in using a local heating at a high temperature (around 1800 C) for a short time to avoid the degradation of the composite structure. The assemblies have been then performed in an inductive furnace but in order to prepare the joining technology, trials of local heating have also been investigated with a CO 2 laser beam and a microwave generator. Finally, descriptions of the 4-points bending mechanical test used and the associated results are presented. (author) [fr

  6. Microstructure and properties of ceramics and composites joined by plastic deformation.

    Energy Technology Data Exchange (ETDEWEB)

    Goretta, K. C.; Singh, D.; Chen, N.; Gutierrez-Mora, F.; Lorenzo-Martin, M. de la, Cinta; Dominguez-Rodriguez, A.; Routbort, J. L.; Energy Systems; Univ. of Seville

    2008-12-01

    A review is presented of the design of suitable materials systems for joining by high-temperature plastic deformation, details of the joining techniques, microstructures and properties of the resulting composite bodies, and prospects and limitation for this type of joining technology. Joining parameters and resulting forms are discussed for Al{sub 2}O{sub 3}/mullite particulate composites, Y{sub 2}O{sub 3}-stabilized ZrO{sub 2} particulate/Al{sub 2}O{sub 3} particulate and whisker-reinforced composites, hydroxyapatite bioceramics, La{sub 0.85}Sr{sub 0.15}MnO{sub 3} electronic ceramics, MgF{sub 2} optical ceramics, and Ni{sub 3}Al intermetallics. Results are contrasted with those obtained by other methods of joining brittle, high-temperature materials, with special focus on durability and mechanical properties.

  7. Microstructure and properties of ceramics and composites joined by plastic deformation

    Energy Technology Data Exchange (ETDEWEB)

    Goretta, K.C. [Argonne National Laboratory, Argonne, IL 60439-4838 (United States)], E-mail: ken.goretta@aoard.af.mil; Singh, D.; Chen Nan [Argonne National Laboratory, Argonne, IL 60439-4838 (United States); Gutierrez-Mora, F.; Cinta Lorenzo-Martin, M. de la [Argonne National Laboratory, Argonne, IL 60439-4838 (United States); University of Seville, Seville 41080 (Spain); Dominguez-Rodriguez, A. [University of Seville, Seville 41080 (Spain); Routbort, J.L. [Argonne National Laboratory, Argonne, IL 60439-4838 (United States)

    2008-12-20

    A review is presented of the design of suitable materials systems for joining by high-temperature plastic deformation, details of the joining techniques, microstructures and properties of the resulting composite bodies, and prospects and limitation for this type of joining technology. Joining parameters and resulting forms are discussed for Al{sub 2}O{sub 3}/mullite particulate composites, Y{sub 2}O{sub 3}-stabilized ZrO{sub 2} particulate/Al{sub 2}O{sub 3} particulate and whisker-reinforced composites, hydroxyapatite bioceramics, La{sub 0.85}Sr{sub 0.15}MnO{sub 3} electronic ceramics, MgF{sub 2} optical ceramics, and Ni{sub 3}Al intermetallics. Results are contrasted with those obtained by other methods of joining brittle, high-temperature materials, with special focus on durability and mechanical properties.

  8. Nearest neighbors by neighborhood counting.

    Science.gov (United States)

    Wang, Hui

    2006-06-01

    Finding nearest neighbors is a general idea that underlies many artificial intelligence tasks, including machine learning, data mining, natural language understanding, and information retrieval. This idea is explicitly used in the k-nearest neighbors algorithm (kNN), a popular classification method. In this paper, this idea is adopted in the development of a general methodology, neighborhood counting, for devising similarity functions. We turn our focus from neighbors to neighborhoods, a region in the data space covering the data point in question. To measure the similarity between two data points, we consider all neighborhoods that cover both data points. We propose to use the number of such neighborhoods as a measure of similarity. Neighborhood can be defined for different types of data in different ways. Here, we consider one definition of neighborhood for multivariate data and derive a formula for such similarity, called neighborhood counting measure or NCM. NCM was tested experimentally in the framework of kNN. Experiments show that NCM is generally comparable to VDM and its variants, the state-of-the-art distance functions for multivariate data, and, at the same time, is consistently better for relatively large k values. Additionally, NCM consistently outperforms HEOM (a mixture of Euclidean and Hamming distances), the "standard" and most widely used distance function for multivariate data. NCM has a computational complexity in the same order as the standard Euclidean distance function and NCM is task independent and works for numerical and categorical data in a conceptually uniform way. The neighborhood counting methodology is proven sound for multivariate data experimentally. We hope it will work for other types of data.

  9. [Identification of Tibetan medicine "Dida" of Gentianaceae using DNA barcoding].

    Science.gov (United States)

    Liu, Chuan; Zhang, Yu-Xin; Liu, Yue; Chen, Yi-Long; Fan, Gang; Xiang, Li; Xu, Jiang; Zhang, Yi

    2016-02-01

    The ITS2 barcode was used toidentify Tibetan medicine "Dida", and tosecure its quality and safety in medication. A total of 13 species, 151 experimental samples for the study from the Tibetan Plateau, including Gentianaceae Swertia, Halenia, Gentianopsis, Comastoma, Lomatogonium ITS2 sequences were amplified, and purified PCR products were sequenced. Sequence assembly and consensus sequence generation were performed using the CodonCode Aligner V3.7.1. The Kimura 2-Parameter (K2P) distances were calculated using MEGA 6.0. The neighbor-joining (NJ) phylogenetic trees were constructed. There are 31 haplotypes among 231 bp after alignment of all ITS2 sequence haplotypes, and the average G±C content of 61.40%. The NJ tree strongly supported that every species clustered into their own clade and high identification success rate, except that Swertia bifolia and Swertia wolfangiana could not be distinguished from each other based on the sequence divergences. DNA barcoding could be used as a fast and accurate identification method to distinguish Tibetan medicine "Dida" to ensure its safe use. Copyright© by the Chinese Pharmaceutical Association.

  10. Molecular phylogeny and larval morphological diversity of the lanternfish genus Hygophum (Teleostei: Myctophidae).

    Science.gov (United States)

    Yamaguchi, M; Miya, M; Okiyama, M; Nishida, M

    2000-04-01

    Larvae of the deep-sea lanternfish genus Hygophum (Myctophidae) exhibit a remarkable morphological diversity that is quite unexpected, considering their homogeneous adult morphology. In an attempt to elucidate the evolutionary patterns of such larval morphological diversity, nucleotide sequences of a portion of the mitochondrially encoded 16S ribosomal RNA gene were determined for seven Hygophum species and three outgroup taxa. Secondary structure-based alignment resulted in a character matrix consisting of 1172 bp of unambiguously aligned sequences, which were subjected to phylogenetic analyses using maximum-parsimony, maximum-likelihood, and neighbor-joining methods. The resultant tree topologies from the three methods were congruent, with most nodes, including that of the genus Hygophum, being strongly supported by various tree statistics. The most parsimonious reconstruction of the three previously recognized, distinct larval morphs onto the molecular phylogeny revealed that one of the morphs had originated as the common ancestor of the genus, the other two having diversified separately in two subsequent major clades. The patterns of such diversification are discussed in terms of the unusual larval eye morphology and geographic distribution. Copyright 2000 Academic Press.

  11. Increasing FSW join strength by optimizing feed rate, rotating speed and pin angle

    Science.gov (United States)

    Darmadi, Djarot B.; Purnowidodo, Anindito; Siswanto, Eko

    2017-10-01

    Principally the join in Friction Stir Welding (FSW) is formed due to mechanical bonding. At least there are two factors determines the quality of this join, first is the temperature in the area around the interface and secondly the intense of mixing forces in nugget zone to create the mechanical bonding. The adequate temperature creates good flowability of the nugget zone and an intensive mixing force produces homogeneous strong bonding. Based on those two factors in this research the effects of feed rate, rotating speed and pin angle of the FSW process to the tensile strength of resulted join are studied. The true experimental method was used. Feed rate was varied at 24, 42, 55 and 74 mm/minutes and from the experimental results, it can be concluded that the higher feed rate decreases the tensile strength of weld join and it is believed due to the lower heat embedded in the material. Inversely, the higher rotating speed increases the join’s tensile strength as a result of higher heat embedded in base metal and higher mixing force in the nugget zone. The rotating speed were 1842, 2257 and 2904 RPMs. The pin angle determines the direction of mixing force. With variation of pin angle: 0°, 4°, 8° and 12° the higher pin angle generally increases the tensile strength because of more intensive mixing force. For 12° pin angle the lower tensile strength is found since the force tends to push out the nugget area from the joint gap.

  12. The relative importance of above- versus belowground competition for tree growth and survival during early succession of a tropical moist forest

    NARCIS (Netherlands)

    Breugel, van M.; Breugel, van P.; Jansen, P.A.; Martinez-Ramos, M.; Bongers, F.

    2012-01-01

    Competition between neighboring plants plays a major role in the population dynamics of tree species in the early phases of humid tropical forest succession. We evaluated the relative importance of above- versus below-ground competition during the first years of old-field succession on soil with low

  13. Joining of Aluminium Alloy Sheets by Rectangular Mechanical Clinching

    International Nuclear Information System (INIS)

    Abe, Y.; Mori, K.; Kato, T.

    2011-01-01

    A mechanical clinching has the advantage of low running costs. However, the joint strength is not high. To improve the maximum load of the joined sheets by a mechanical clinching, square and rectangular mechanical clinching were introduced. In the mechanical clinching, the two sheets are mechanically joined by forming an interlock between the lower and upper sheets by the punch and die. The joined length with the interlock was increased by the rectangular punch and die. The deforming behaviours of the sheets in the mechanical clinching were investigated, and then the interlock in the sheets had distribution in the circumference of the projection. Although the interlocks were formed in both projection side and diagonal, the interlock in the diagonal was smaller because of the long contact length between the lower sheet and the die cavity surface. The maximum load of the joined sheets by the rectangular mechanical clinching was two times larger than the load by the round mechanical clinching.

  14. Construction of a phylogenetic tree of photosynthetic prokaryotes based on average similarities of whole genome sequences.

    Directory of Open Access Journals (Sweden)

    Soichirou Satoh

    Full Text Available Phylogenetic trees have been constructed for a wide range of organisms using gene sequence information, especially through the identification of orthologous genes that have been vertically inherited. The number of available complete genome sequences is rapidly increasing, and many tools for construction of genome trees based on whole genome sequences have been proposed. However, development of a reasonable method of using complete genome sequences for construction of phylogenetic trees has not been established. We have developed a method for construction of phylogenetic trees based on the average sequence similarities of whole genome sequences. We used this method to examine the phylogeny of 115 photosynthetic prokaryotes, i.e., cyanobacteria, Chlorobi, proteobacteria, Chloroflexi, Firmicutes and nonphotosynthetic organisms including Archaea. Although the bootstrap values for the branching order of phyla were low, probably due to lateral gene transfer and saturated mutation, the obtained tree was largely consistent with the previously reported phylogenetic trees, indicating that this method is a robust alternative to traditional phylogenetic methods.

  15. Rare itemsets mining algorithm based on RP-Tree and spark framework

    Science.gov (United States)

    Liu, Sainan; Pan, Haoan

    2018-05-01

    For the issues of the rare itemsets mining in big data, this paper proposed a rare itemsets mining algorithm based on RP-Tree and Spark framework. Firstly, it arranged the data vertically according to the transaction identifier, in order to solve the defects of scan the entire data set, the vertical datasets are divided into frequent vertical datasets and rare vertical datasets. Then, it adopted the RP-Tree algorithm to construct the frequent pattern tree that contains rare items and generate rare 1-itemsets. After that, it calculated the support of the itemsets by scanning the two vertical data sets, finally, it used the iterative process to generate rare itemsets. The experimental show that the algorithm can effectively excavate rare itemsets and have great superiority in execution time.

  16. Fast and scalable inequality joins

    KAUST Repository

    Khayyat, Zuhair; Lucia, William; Singh, Meghna; Ouzzani, Mourad; Papotti, Paolo; Quiané -Ruiz, Jorge Arnulfo; Tang, Nan; Kalnis, Panos

    2016-01-01

    an incremental inequality join algorithm to handle scenarios where data keeps changing. We have implemented a centralized version of these algorithms on top of PostgreSQL, a distributed version on top of Spark SQL, and an existing data cleaning system, Nadeef

  17. Sequence correction of random coil chemical shifts: correlation between neighbor correction factors and changes in the Ramachandran distribution

    DEFF Research Database (Denmark)

    Kjærgaard, Magnus; Poulsen, Flemming Martin

    2011-01-01

    Random coil chemical shifts are necessary for secondary chemical shift analysis, which is the main NMR method for identification of secondary structure in proteins. One of the largest challenges in the determination of random coil chemical shifts is accounting for the effect of neighboring residues....... The contributions from the neighboring residues are typically removed by using neighbor correction factors determined based on each residue's effect on glycine chemical shifts. Due to its unusual conformational freedom, glycine may be particularly unrepresentative for the remaining residue types. In this study, we...... in the conformational ensemble are an important source of neighbor effects in disordered proteins. Glutamine derived random coil chemical shifts and correction factors modestly improve our ability to predict (13)C chemical shifts of intrinsically disordered proteins compared to existing datasets, and may thus improve...

  18. Neighboring Genes Show Correlated Evolution in Gene Expression

    Science.gov (United States)

    Ghanbarian, Avazeh T.; Hurst, Laurence D.

    2015-01-01

    When considering the evolution of a gene’s expression profile, we commonly assume that this is unaffected by its genomic neighborhood. This is, however, in contrast to what we know about the lack of autonomy between neighboring genes in gene expression profiles in extant taxa. Indeed, in all eukaryotic genomes genes of similar expression-profile tend to cluster, reflecting chromatin level dynamics. Does it follow that if a gene increases expression in a particular lineage then the genomic neighbors will also increase in their expression or is gene expression evolution autonomous? To address this here we consider evolution of human gene expression since the human-chimp common ancestor, allowing for both variation in estimation of current expression level and error in Bayesian estimation of the ancestral state. We find that in all tissues and both sexes, the change in gene expression of a focal gene on average predicts the change in gene expression of neighbors. The effect is highly pronounced in the immediate vicinity (genes increasing their expression in humans tend to avoid nuclear lamina domains and be enriched for the gene activator 5-hydroxymethylcytosine, we conclude that, most probably owing to chromatin level control of gene expression, a change in gene expression of one gene likely affects the expression evolution of neighbors, what we term expression piggybacking, an analog of hitchhiking. PMID:25743543

  19. A Walk-based Semantically Enriched Tree Kernel Over Distributed Word Representations

    DEFF Research Database (Denmark)

    Srivastava, Shashank; Hovy, Dirk

    2013-01-01

    We propose a walk-based graph kernel that generalizes the notion of tree-kernels to continuous spaces. Our proposed approach subsumes a general framework for word-similarity, and in particular, provides a flexible way to incorporate distributed representations. Using vector representations......, such an approach captures both distributional semantic similarities among words as well as the structural relations between them (encoded as the structure of the parse tree). We show an efficient formulation to compute this kernel using simple matrix multiplication operations. We present our results on three...

  20. Storage and recycling utilization of leaf-nitrogen of jujube tree

    International Nuclear Information System (INIS)

    Zeng Xiang; Hao Zhongning

    1991-01-01

    16 N-urea was foliarly applied on bearing or young jujube tree in autumn of 1987. The effects of leaf-nitrogen retranslocation in the trees, positions of the N stored, forms of reserved N, and reutilization of storage N in the next year were studied. The results were as follows: 15 N returned and stored in all parts of the tree following foliar application of 15 N-urea. Root could use the nitrogen not only absorbed from soil but also transported from leaves. The above-ground organs and roots of jujube tree played the same important roles on nitrogen storage in winter. The main forms of storage nitrogen were protein-N, which was 2-3 fold more than non-protein-N. The storage nitrogen existed in above-ground parts was used first in early spring, and that returned from leaves last year could be prior used for the developments of leaves, branchlets and infloresences. The relative distribution of nitrogen in floresence was more in bearing tree than in young tree. In the next year, 15 N was redistributed in branchlets, leaves, flowers, young fruits and perennial spurs in autumn. The 15 N transported out of the treated spurs reappeared in next spring and further transported to neighboring spurs. The local storage N was prior used for growth. There was 21.49% of fertilizer-N stored in the young jujube trees when treated foliarly with urea in autumn of 1987. After one years's use, there was still 18.91% of fertilizer-N existed in the trees, which indicated a characteristic of circulatory utilization of nitrogen for a long period and the reutilized nitrogen was mainly from jujube leaves and deciduous branchlets

  1. 49 CFR 192.283 - Plastic pipe: Qualifying joining procedures.

    Science.gov (United States)

    2010-10-01

    ... 49 Transportation 3 2010-10-01 2010-10-01 false Plastic pipe: Qualifying joining procedures. 192... Materials Other Than by Welding § 192.283 Plastic pipe: Qualifying joining procedures. (a) Heat fusion... for making plastic pipe joints by a heat fusion, solvent cement, or adhesive method, the procedure...

  2. Construction of phylogenetic trees by kernel-based comparative analysis of metabolic networks.

    Science.gov (United States)

    Oh, S June; Joung, Je-Gun; Chang, Jeong-Ho; Zhang, Byoung-Tak

    2006-06-06

    To infer the tree of life requires knowledge of the common characteristics of each species descended from a common ancestor as the measuring criteria and a method to calculate the distance between the resulting values of each measure. Conventional phylogenetic analysis based on genomic sequences provides information about the genetic relationships between different organisms. In contrast, comparative analysis of metabolic pathways in different organisms can yield insights into their functional relationships under different physiological conditions. However, evaluating the similarities or differences between metabolic networks is a computationally challenging problem, and systematic methods of doing this are desirable. Here we introduce a graph-kernel method for computing the similarity between metabolic networks in polynomial time, and use it to profile metabolic pathways and to construct phylogenetic trees. To compare the structures of metabolic networks in organisms, we adopted the exponential graph kernel, which is a kernel-based approach with a labeled graph that includes a label matrix and an adjacency matrix. To construct the phylogenetic trees, we used an unweighted pair-group method with arithmetic mean, i.e., a hierarchical clustering algorithm. We applied the kernel-based network profiling method in a comparative analysis of nine carbohydrate metabolic networks from 81 biological species encompassing Archaea, Eukaryota, and Eubacteria. The resulting phylogenetic hierarchies generally support the tripartite scheme of three domains rather than the two domains of prokaryotes and eukaryotes. By combining the kernel machines with metabolic information, the method infers the context of biosphere development that covers physiological events required for adaptation by genetic reconstruction. The results show that one may obtain a global view of the tree of life by comparing the metabolic pathway structures using meta-level information rather than sequence

  3. Construction of phylogenetic trees by kernel-based comparative analysis of metabolic networks

    Directory of Open Access Journals (Sweden)

    Chang Jeong-Ho

    2006-06-01

    Full Text Available Abstract Background To infer the tree of life requires knowledge of the common characteristics of each species descended from a common ancestor as the measuring criteria and a method to calculate the distance between the resulting values of each measure. Conventional phylogenetic analysis based on genomic sequences provides information about the genetic relationships between different organisms. In contrast, comparative analysis of metabolic pathways in different organisms can yield insights into their functional relationships under different physiological conditions. However, evaluating the similarities or differences between metabolic networks is a computationally challenging problem, and systematic methods of doing this are desirable. Here we introduce a graph-kernel method for computing the similarity between metabolic networks in polynomial time, and use it to profile metabolic pathways and to construct phylogenetic trees. Results To compare the structures of metabolic networks in organisms, we adopted the exponential graph kernel, which is a kernel-based approach with a labeled graph that includes a label matrix and an adjacency matrix. To construct the phylogenetic trees, we used an unweighted pair-group method with arithmetic mean, i.e., a hierarchical clustering algorithm. We applied the kernel-based network profiling method in a comparative analysis of nine carbohydrate metabolic networks from 81 biological species encompassing Archaea, Eukaryota, and Eubacteria. The resulting phylogenetic hierarchies generally support the tripartite scheme of three domains rather than the two domains of prokaryotes and eukaryotes. Conclusion By combining the kernel machines with metabolic information, the method infers the context of biosphere development that covers physiological events required for adaptation by genetic reconstruction. The results show that one may obtain a global view of the tree of life by comparing the metabolic pathway

  4. SWPhylo - A Novel Tool for Phylogenomic Inferences by Comparison of Oligonucleotide Patterns and Integration of Genome-Based and Gene-Based Phylogenetic Trees.

    Science.gov (United States)

    Yu, Xiaoyu; Reva, Oleg N

    2018-01-01

    Modern phylogenetic studies may benefit from the analysis of complete genome sequences of various microorganisms. Evolutionary inferences based on genome-scale analysis are believed to be more accurate than the gene-based alternative. However, the computational complexity of current phylogenomic procedures, inappropriateness of standard phylogenetic tools to process genome-wide data, and lack of reliable substitution models which correlates with alignment-free phylogenomic approaches deter microbiologists from using these opportunities. For example, the super-matrix and super-tree approaches of phylogenomics use multiple integrated genomic loci or individual gene-based trees to infer an overall consensus tree. However, these approaches potentially multiply errors of gene annotation and sequence alignment not mentioning the computational complexity and laboriousness of the methods. In this article, we demonstrate that the annotation- and alignment-free comparison of genome-wide tetranucleotide frequencies, termed oligonucleotide usage patterns (OUPs), allowed a fast and reliable inference of phylogenetic trees. These were congruent to the corresponding whole genome super-matrix trees in terms of tree topology when compared with other known approaches including 16S ribosomal RNA and GyrA protein sequence comparison, complete genome-based MAUVE, and CVTree methods. A Web-based program to perform the alignment-free OUP-based phylogenomic inferences was implemented at http://swphylo.bi.up.ac.za/. Applicability of the tool was tested on different taxa from subspecies to intergeneric levels. Distinguishing between closely related taxonomic units may be enforced by providing the program with alignments of marker protein sequences, eg, GyrA.

  5. A stable RNA virus-based vector for citrus trees

    International Nuclear Information System (INIS)

    Folimonov, Alexey S.; Folimonova, Svetlana Y.; Bar-Joseph, Moshe; Dawson, William O.

    2007-01-01

    Virus-based vectors are important tools in plant molecular biology and plant genomics. A number of vectors based on viruses that infect herbaceous plants are in use for expression or silencing of genes in plants as well as screening unknown sequences for function. Yet there is a need for useful virus-based vectors for woody plants, which demand much greater stability because of the longer time required for systemic infection and analysis. We examined several strategies to develop a Citrus tristeza virus (CTV)-based vector for transient expression of foreign genes in citrus trees using a green fluorescent protein (GFP) as a reporter. These strategies included substitution of the p13 open reading frame (ORF) by the ORF of GFP, construction of a self-processing fusion of GFP in-frame with the major coat protein (CP), or expression of the GFP ORF as an extra gene from a subgenomic (sg) mRNA controlled either by a duplicated CTV CP sgRNA controller element (CE) or an introduced heterologous CE of Beet yellows virus. Engineered vector constructs were examined for replication, encapsidation, GFP expression during multiple passages in protoplasts, and for their ability to infect, move, express GFP, and be maintained in citrus plants. The most successful vectors based on the 'add-a-gene' strategy have been unusually stable, continuing to produce GFP fluorescence after more than 4 years in citrus trees

  6. Credit scoring analysis using weighted k nearest neighbor

    Science.gov (United States)

    Mukid, M. A.; Widiharih, T.; Rusgiyono, A.; Prahutama, A.

    2018-05-01

    Credit scoring is a quatitative method to evaluate the credit risk of loan applications. Both statistical methods and artificial intelligence are often used by credit analysts to help them decide whether the applicants are worthy of credit. These methods aim to predict future behavior in terms of credit risk based on past experience of customers with similar characteristics. This paper reviews the weighted k nearest neighbor (WKNN) method for credit assessment by considering the use of some kernels. We use credit data from a private bank in Indonesia. The result shows that the Gaussian kernel and rectangular kernel have a better performance based on the value of percentage corrected classified whose value is 82.4% respectively.

  7. A MongoDB-Based Management of Planar Spatial Data with a Flattened R-Tree

    Directory of Open Access Journals (Sweden)

    Longgang Xiang

    2016-07-01

    Full Text Available This paper addresses how to manage planar spatial data using MongoDB, a popular NoSQL database characterized as a document-oriented, rich query language and high availability. The core idea is to flatten a hierarchical R-tree structure into a tabular MongoDB collection, during which R-tree nodes are represented as collection documents and R-tree pointers are expressed as document identifiers. By following this strategy, a storage schema to support R-tree-based create, read, update, and delete (CRUD operations is designed and a module to manage planar spatial data by consuming and maintaining flattened R-tree structure is developed. The R-tree module is then seamlessly integrated into MongoDB, so that users could manipulate planar spatial data with existing command interfaces oriented to geodetic spatial data. The experimental evaluation, using real-world datasets with diverse coverage, types, and sizes, shows that planar spatial data can be effectively managed by MongoDB with our flattened R-tree and, therefore, the application extent of MongoDB will be greatly enlarged. Our work resulted in a MongoDB branch with R-tree support, which has been released on GitHub for open access.

  8. Joining technologies for the plasma facing components of ITER

    International Nuclear Information System (INIS)

    Barabash, V.; Kalinin, G.; Matera, R.

    1998-01-01

    An extensive R and D program on the development of the joining technologies between armour (beryllium, tungsten and carbon fibre composites)/copper alloys heat sink and copper alloys/ stainless steel has been carried out by ITER Home Teams. A brief review of this R and D program is presented in this paper. Based on the results, reference technologies for use in ITER have been selected and recommended for further development. (author)

  9. Development of a procedure for forming assisted thermal joining of tubes

    Science.gov (United States)

    Chen, Hui; Löbbe, Christian; Staupendahl, Daniel; Tekkaya, A. Erman

    2018-05-01

    With the demand of lightweight design in the automotive industry, not only the wall-thicknesses of tubular components of the chassis or spaceframe are continuously decreased. Also the thicknesses of exhaust system parts are reduced to save material and mass. However, thinner tubular parts bring about additional challenges in joining. Welding or brazing methods, which are utilized in joining tubes with specific requirements concerning leak tightness, are sensitive to the gap between the joining partners. Furthermore, a large joining area is required to ensure the durability of the joint. The introduction of a forming step in the assembled state prior to thermal joining can define and control the gap for subsequent brazing or welding. The mechanical pre-joint resulting from the previously described calibration step also results in easier handling of the tubes prior to thermal joining. In the presented investigation, a spinning process is utilized to produce force-fit joints of varying lengths and diameter reduction and form-fit joints with varying geometrical attributes. The spinning process facilitates a high formability and geometrical flexibility, while at the achievable precision is high and the process forces are low. The strength of the joints is used to evaluate the joint quality. Finally, a comparison between joints produced by forming with subsequent brazing and original tube is conducted, which presents the high performance of the developed procedure for forming assisted thermal joining.

  10. Exploring the utility of DNA barcoding in species delimitation of Polypedilum (Tripodura) non-biting midges (Diptera: Chironomidae).

    Science.gov (United States)

    Song, Chao; Wang, Qian; Zhang, Ruilei; Sun, Bingjiao; Wang, Xinhua

    2016-02-16

    In this study, we tested the utility of the mitochondrial gene cytochrome c oxidase subunit 1 (CO1) as the barcode region to deal with taxonomical problems of Polypedilum (Tripodura) non-biting midges (Diptera: Chironomidae). The 114 DNA barcodes representing 27 morphospecies are divided into 33 well separated clusters based on both Neighbor Joining and Maximum Likelihood methods. DNA barcodes revealed an 82% success rate in matching with morphospecies. The selected DNA barcode data support 37-64 operational taxonomic units (OTUs) based on the methods of Automatic Barcode Gap Discovery (ABGD) and Poisson Tree Process (PTP). Furthermore, a priori species based on consistent phenotypic variations were attested by molecular analysis, and a taxonomical misidentification of barcode sequences from GenBank was found. We could not observe a distinct barcode gap but an overlap ranged from 9-12%. Our results supported DNA barcoding as an ideal method to detect cryptic species, delimit sibling species, and associate different life stages in non-biting midges.

  11. Data Clustering and Evolving Fuzzy Decision Tree for Data Base Classification Problems

    Science.gov (United States)

    Chang, Pei-Chann; Fan, Chin-Yuan; Wang, Yen-Wen

    Data base classification suffers from two well known difficulties, i.e., the high dimensionality and non-stationary variations within the large historic data. This paper presents a hybrid classification model by integrating a case based reasoning technique, a Fuzzy Decision Tree (FDT), and Genetic Algorithms (GA) to construct a decision-making system for data classification in various data base applications. The model is major based on the idea that the historic data base can be transformed into a smaller case-base together with a group of fuzzy decision rules. As a result, the model can be more accurately respond to the current data under classifying from the inductions by these smaller cases based fuzzy decision trees. Hit rate is applied as a performance measure and the effectiveness of our proposed model is demonstrated by experimentally compared with other approaches on different data base classification applications. The average hit rate of our proposed model is the highest among others.

  12. Model Checking Processes Specified In Join-Calculus Algebra

    Directory of Open Access Journals (Sweden)

    Sławomir Piotr Maludziński

    2014-01-01

    Full Text Available This article presents a model checking tool used to verify concurrent systems specified in join-calculus algebra. The temporal properties of systems under verification are expressed in CTL logic. Join-calculus algebra with its operational semantics defined by the chemical abstract machine serves as the basic method for the specification of concurrent systems and their synchronization mechanisms, and allows the examination of more complex systems.

  13. Ozone uptake by adult urban trees based on sap flow measurement

    International Nuclear Information System (INIS)

    Wang Hua; Zhou Weiqi; Wang Xiaoke; Gao Fuyuan; Zheng Hua; Tong Lei; Ouyang Zhiyun

    2012-01-01

    The O 3 uptake in 17 adult trees of six urban species was evaluated by the sap flow-based approach under free atmospheric conditions. The results showed very large species differences in ground area scaled whole-tree ozone uptake (F O 3 ), with estimates ranging from 0.61 ± 0.07 nmol m −2 s −1 in Robinia pseudoacacia to 4.80 ± 1.04 nmol m −2 s −1 in Magnolia liliiflora. However, average F O 3 by deciduous foliages was not significantly higher than that by evergreen ones (3.13 vs 2.21 nmol m −2 s −1 , p = 0.160). Species of high canopy conductance for O 3 (G O 3 ) took up more O 3 than those of low G O 3 , but that their sensitivity to vapour pressure deficit (D) were also higher, and their F O 3 decreased faster with increasing D, regardless of species. The responses of F O 3 to D and total radiation led to the relative high flux of O 3 uptake, indicating high ozone risk for urban tree species. - Highlights: ► O 3 uptake by urban trees varied considering contrasting species and study period. ►The responses of G O 3 to microclimate lead to relative high O 3 uptake by urban trees. ►Many urban species are susceptible to O 3 damage. ►The annual O 3 uptake in our study is greatly less than that from modeling approaches. ►The difference suggests considering the species-specific flux in O 3 risk assessment. - Sap flow-based O 3 uptake among urban species suggests high capacity and variation of ozone uptake, as well as potentially detrimental effects to urban species.

  14. Forest FIRE and FIRE wood : tools for tree automata and tree algorithms

    NARCIS (Netherlands)

    Cleophas, L.G.W.A.; Piskorski, J.; Watson, B.W.; Yli-Jyrä, A.

    2009-01-01

    Pattern matching, acceptance, and parsing algorithms on node-labeled, ordered, ranked trees ('tree algorithms') are important for applications such as instruction selection and tree transformation/term rewriting. Many such algorithms have been developed. They often are based on results from such

  15. An RFID Indoor Positioning Algorithm Based on Bayesian Probability and K-Nearest Neighbor

    Directory of Open Access Journals (Sweden)

    He Xu

    2017-08-01

    Full Text Available The Global Positioning System (GPS is widely used in outdoor environmental positioning. However, GPS cannot support indoor positioning because there is no signal for positioning in an indoor environment. Nowadays, there are many situations which require indoor positioning, such as searching for a book in a library, looking for luggage in an airport, emergence navigation for fire alarms, robot location, etc. Many technologies, such as ultrasonic, sensors, Bluetooth, WiFi, magnetic field, Radio Frequency Identification (RFID, etc., are used to perform indoor positioning. Compared with other technologies, RFID used in indoor positioning is more cost and energy efficient. The Traditional RFID indoor positioning algorithm LANDMARC utilizes a Received Signal Strength (RSS indicator to track objects. However, the RSS value is easily affected by environmental noise and other interference. In this paper, our purpose is to reduce the location fluctuation and error caused by multipath and environmental interference in LANDMARC. We propose a novel indoor positioning algorithm based on Bayesian probability and K-Nearest Neighbor (BKNN. The experimental results show that the Gaussian filter can filter some abnormal RSS values. The proposed BKNN algorithm has the smallest location error compared with the Gaussian-based algorithm, LANDMARC and an improved KNN algorithm. The average error in location estimation is about 15 cm using our method.

  16. Performance Comparison of the Optimized Inverted Joined Wing Airplane Concept and Classical Configuration Airplanes

    Directory of Open Access Journals (Sweden)

    Sieradzki Adam

    2016-09-01

    Full Text Available The joined wing concept is an unconventional airplane configuration, known since the mid-twenties of the last century. It has several possible advantages, like reduction of the induced drag and weight due to the closed wing concept. The inverted joined wing variant is its rarely considered version, with the front wing being situated above the aft wing. The following paper presents a performance prediction of the recently optimized configuration of this airplane. Flight characteristics obtained numerically were compared with the performance of two classical configuration airplanes of similar category. Their computational fluid dynamics (CFD models were created basing on available documentation, photographs and some inverse engineering methods. The analysis included simulations performed for a scale of 3-meter wingspan inverted joined wing demonstrator and also for real-scale manned airplanes. Therefore, the results of CFD calculations allowed us to assess the competitiveness of the presented concept, as compared to the most technologically advanced airplanes designed and manufactured to date. At the end of the paper, the areas where the inverted joined wing is better than conventional airplane were predicted and new research possibilities were described.

  17. The Islands Approach to Nearest Neighbor Querying in Spatial Networks

    DEFF Research Database (Denmark)

    Huang, Xuegang; Jensen, Christian Søndergaard; Saltenis, Simonas

    2005-01-01

    , and versatile approach to k nearest neighbor computation that obviates the need for using several k nearest neighbor approaches for supporting a single service scenario. The experimental comparison with the existing techniques uses real-world road network data and considers both I/O and CPU performance...

  18. Urban tree growth modeling

    Science.gov (United States)

    E. Gregory McPherson; Paula J. Peper

    2012-01-01

    This paper describes three long-term tree growth studies conducted to evaluate tree performance because repeated measurements of the same trees produce critical data for growth model calibration and validation. Several empirical and process-based approaches to modeling tree growth are reviewed. Modeling is more advanced in the fields of forestry and...

  19. Glass-Metal Joining in Nuclear Environment: the State of the Art

    International Nuclear Information System (INIS)

    Jacobs, M.

    2007-01-01

    Full text of publication follows: In the ITER fusion machine and in material testing fission reactors, it is not possible to avoid the use of non-metallic materials like glass for example. There is therefore a need to apply metal to glass joints. This problem arose already at the beginning of the 19. century when the electric light bulb was invented. Nowadays this type of glass-metal joint is very successful and widely used in the electronic industry. In the case of ITER and material testing reactors, glass-metal joints are necessary for the fixation of the optical windows and optical fibres to a metal structure to perform diagnostics. These types of joints are still difficult to make and their behaviour is not fully understood. A joint between glass and metal for a nuclear or fusion application has indeed to resist high temperatures and high neutron fluences, while keeping a good mechanical strength and remaining leak tight. These characteristics are difficult to obtain under these severe conditions. This paper presents an overview of the different joining technologies that can be used to join glass to metal in a severe nuclear environment. The working mechanism of the technologies are explained, together with their respective advantages and drawbacks. Three different types of joining are discussed: fastening, liquid phase joining and solid phase joining. Fastening is a mechanical attachment technique, not achieving easily hermetic seals. Liquid and solid phase joining on the other hand form a real bond, what makes the joint much stronger. The most important technologies using liquid phase joining are adhesive bonding, fusion welding and brazing. In the case of the solid phase joining the choices are ultrasonic torsion welding, diffusion bonding and electrostatic bonding. If it is usually not possible to join the glass directly to the metal, an interlayer must be used. One speaks then of indirect joining. The paper will conclude with a discussion on the best

  20. Tree detection in urban regions from aerial imagery and DSM based on local maxima points

    Science.gov (United States)

    Korkmaz, Özgür; Yardımcı ćetin, Yasemin; Yilmaz, Erdal

    2017-05-01

    In this study, we propose an automatic approach for tree detection and classification in registered 3-band aerial images and associated digital surface models (DSM). The tree detection results can be used in 3D city modelling and urban planning. This problem is magnified when trees are in close proximity to each other or other objects such as rooftops in the scenes. This study presents a method for locating individual trees and estimation of crown size based on local maxima from DSM accompanied by color and texture information. For this purpose, segment level classifier trained for 10 classes and classification results are improved by analyzing the class probabilities of neighbour segments. Later, the tree classes under a certain height were eliminated using the Digital Terrain Model (DTM). For the tree classes, local maxima points are obtained and the tree radius estimate is made from the vertical and horizontal height profiles passing through these points. The final tree list containing the centers and radius of the trees is obtained by selecting from the list of tree candidates according to the overlapping and selection parameters. Although the limited number of train sets are used in this study, tree classification and localization results are competitive.

  1. International Symposium on Interfacial Joining and Surface Technology (IJST2013)

    International Nuclear Information System (INIS)

    Takahashi, Yasuo

    2014-01-01

    Interfacial joining (bonding) is a widely accepted welding process and one of the environmentally benign technologies used in industrial production. As the bonding temperature is lower than the melting point of the parent materials, melting of the latter is kept to a minimum. The process can be based on diffusion bonding, pressure welding, friction welding, ultrasonic bonding, or brazing-soldering, all of which offer many advantages over fusion welding. In addition, surface technologies such as surface modification, spraying, coating, plating, and thin-film formation are necessary for advanced manufacturing, fabrication, and electronics packaging. Together, interfacial joining and surface technology (IJST) will continue to be used in various industrial fields because IJST is a very significant form of environmentally conscious materials processing. The international symposium of IJST 2013 was held at Icho Kaikan, Osaka University, Japan from 27–29 November, 2013. A total of 138 participants came from around the world to attend 56 oral presentations and 36 posters presented at the symposium, and to discuss the latest research and developments on interfacial joining and surface technologies. This symposium was also held to commemorate the 30th anniversary of the Technical Commission on Interfacial Joining of the Japan Welding Society. On behalf of the chair of the symposium, it is my great pleasure to present this volume of IOP Conference Series: Materials Science and Engineering (MSE). Among the presentations, 43 papers are published here, and I believe all of the papers have provided the welding community with much useful information. I would like to thank the authors for their enthusiastic and excellent contributions. Finally, I would like to thank all members of the committees, secretariats, participants, and everyone who contributed to this symposium through their support and invaluable effort for the success of IJST 2013. Yasuo Takahashi Chair of IJST 2013

  2. International Symposium on Interfacial Joining and Surface Technology (IJST2013)

    Science.gov (United States)

    Takahashi, Yasuo

    2014-08-01

    Interfacial joining (bonding) is a widely accepted welding process and one of the environmentally benign technologies used in industrial production. As the bonding temperature is lower than the melting point of the parent materials, melting of the latter is kept to a minimum. The process can be based on diffusion bonding, pressure welding, friction welding, ultrasonic bonding, or brazing-soldering, all of which offer many advantages over fusion welding. In addition, surface technologies such as surface modification, spraying, coating, plating, and thin-film formation are necessary for advanced manufacturing, fabrication, and electronics packaging. Together, interfacial joining and surface technology (IJST) will continue to be used in various industrial fields because IJST is a very significant form of environmentally conscious materials processing. The international symposium of IJST 2013 was held at Icho Kaikan, Osaka University, Japan from 27-29 November, 2013. A total of 138 participants came from around the world to attend 56 oral presentations and 36 posters presented at the symposium, and to discuss the latest research and developments on interfacial joining and surface technologies. This symposium was also held to commemorate the 30th anniversary of the Technical Commission on Interfacial Joining of the Japan Welding Society. On behalf of the chair of the symposium, it is my great pleasure to present this volume of IOP Conference Series: Materials Science and Engineering (MSE). Among the presentations, 43 papers are published here, and I believe all of the papers have provided the welding community with much useful information. I would like to thank the authors for their enthusiastic and excellent contributions. Finally, I would like to thank all members of the committees, secretariats, participants, and everyone who contributed to this symposium through their support and invaluable effort for the success of IJST 2013. Yasuo Takahashi Chair of IJST 2013

  3. An object-oriented classification method of high resolution imagery based on improved AdaTree

    International Nuclear Information System (INIS)

    Xiaohe, Zhang; Liang, Zhai; Jixian, Zhang; Huiyong, Sang

    2014-01-01

    With the popularity of the application using high spatial resolution remote sensing image, more and more studies paid attention to object-oriented classification on image segmentation as well as automatic classification after image segmentation. This paper proposed a fast method of object-oriented automatic classification. First, edge-based or FNEA-based segmentation was used to identify image objects and the values of most suitable attributes of image objects for classification were calculated. Then a certain number of samples from the image objects were selected as training data for improved AdaTree algorithm to get classification rules. Finally, the image objects could be classified easily using these rules. In the AdaTree, we mainly modified the final hypothesis to get classification rules. In the experiment with WorldView2 image, the result of the method based on AdaTree showed obvious accuracy and efficient improvement compared with the method based on SVM with the kappa coefficient achieving 0.9242

  4. The relative importance of above- versus belowground competition for tree growth during early succession of a tropical moist forest

    DEFF Research Database (Denmark)

    Breugel, Michiel van; van Breugel, Paulo; Jansen, Patrick A.

    2012-01-01

    and Trichospermum mexicanum, two pioneer species that dominate the secondary forests in the study region, varied with the abundance and size of neighboring trees in 1-2 year old secondary vegetation. We found that local neighborhood basal area varied 10-fold (3 to 30 cm(2) m(-2)) and explained most of the variation...

  5. Taiwan university joins search for antimatter

    CERN Multimedia

    Chiu, Y

    2002-01-01

    National Cheng Kung University announced yesterday that it will be joining the Alpha Magnetic Spectrometer, an international scientific research project aimed at looking for antimatter in space (1 page).

  6. High-energy electron beams for ceramic joining

    Science.gov (United States)

    Turman, Bob N.; Glass, S. J.; Halbleib, J. A.; Helmich, D. R.; Loehman, Ron E.; Clifford, Jerome R.

    1995-03-01

    Joining of structural ceramics is possible using high melting point metals such as Mo and Pt that are heated with a high energy electron beam, with the potential for high temperature joining. A 10 MeV electron beam can penetrate through 1 cm of ceramic, offering the possibility of buried interface joining. Because of transient heating and the lower heat capacity of the metal relative to the ceramic, a pulsed high power beam has the potential for melting the metal without decomposing or melting the ceramic. We have demonstrated the feasibility of the process with a series of 10 MeV, 1 kW electron beam experiments. Shear strengths up to 28 MPa have been measured. This strength is comparable to that reported in the literature for bonding silicon nitride (Si3N4) to molybdenum with copper-silver-titanium braze, but weaker than that reported for Si3N4 - Si3N4 with gold-nickel braze. The bonding mechanism appears to be formation of a thin silicide layer. Beam damage to the Si3N4 was also assessed.

  7. The usages of JOIN2 authority records

    CERN Multimedia

    CERN. Geneva; Thiele, Robert

    2017-01-01

    An important base of the common JOIN2 repository infrastructure of DESY, DKFZ, FZJ, GSI, MLZ and RWTH Aachen are about 134 000 authority records for grants, projects, large-scale infrastructures, cooperations, journals, and different kinds of keys. All instances are using the authorities together. We will present how these authority data are used for different purposes e.g. the recent and upcoming obligations to report to regard to our funding and the data export to openAire. Furthermore, we discuss this in dependence to the German “Kerndatensatz Forschung”, which will be the new standard for future.

  8. Escaping Depressions in LRTS Based on Incremental Refinement of Encoded Quad-Trees

    Directory of Open Access Journals (Sweden)

    Yue Hu

    2017-01-01

    Full Text Available In the context of robot navigation, game AI, and so on, real-time search is extensively used to undertake motion planning. Though it satisfies the requirement of quick response to users’ commands and environmental changes, learning real-time search (LRTS suffers from the heuristic depressions where agents behave irrationally. There have introduced several effective solutions, such as state abstractions. This paper combines LRTS and encoded quad-tree abstraction which represent the search space in multiresolutions. When exploring the environments, agents are enabled to locally repair the quad-tree models and incrementally refine the spatial cognition. By virtue of the idea of state aggregation and heuristic generalization, our EQ LRTS (encoded quad-tree based LRTS possesses the ability of quickly escaping from heuristic depressions with less state revisitations. Experiments and analysis show that (a our encoding principle for quad-trees is a much more memory-efficient method than other data structures expressing quad-trees, (b EQ LRTS differs a lot in several characteristics from classical PR LRTS which represent the space and refine the paths hierarchically, and (c EQ LRTS substantially reduces the planning amount and curtails heuristic updates compared with LRTS on uniform cells.

  9. DNA barcoding of recently diverged species: relative performance of matching methods.

    Directory of Open Access Journals (Sweden)

    Robin van Velzen

    Full Text Available Recently diverged species are challenging for identification, yet they are frequently of special interest scientifically as well as from a regulatory perspective. DNA barcoding has proven instrumental in species identification, especially in insects and vertebrates, but for the identification of recently diverged species it has been reported to be problematic in some cases. Problems are mostly due to incomplete lineage sorting or simply lack of a 'barcode gap' and probably related to large effective population size and/or low mutation rate. Our objective was to compare six methods in their ability to correctly identify recently diverged species with DNA barcodes: neighbor joining and parsimony (both tree-based, nearest neighbor and BLAST (similarity-based, and the diagnostic methods DNA-BAR, and BLOG. We analyzed simulated data assuming three different effective population sizes as well as three selected empirical data sets from published studies. Results show, as expected, that success rates are significantly lower for recently diverged species (∼75% than for older species (∼97% (P<0.00001. Similarity-based and diagnostic methods significantly outperform tree-based methods, when applied to simulated DNA barcode data (P<0.00001. The diagnostic method BLOG had highest correct query identification rate based on simulated (86.2% as well as empirical data (93.1%, indicating that it is a consistently better method overall. Another advantage of BLOG is that it offers species-level information that can be used outside the realm of DNA barcoding, for instance in species description or molecular detection assays. Even though we can confirm that identification success based on DNA barcoding is generally high in our data, recently diverged species remain difficult to identify. Nevertheless, our results contribute to improved solutions for their accurate identification.

  10. Accelerating distributed average consensus by exploring the information of second-order neighbors

    Energy Technology Data Exchange (ETDEWEB)

    Yuan Deming [School of Automation, Nanjing University of Science and Technology, Nanjing 210094, Jiangsu (China); Xu Shengyuan, E-mail: syxu02@yahoo.com.c [School of Automation, Nanjing University of Science and Technology, Nanjing 210094, Jiangsu (China); Zhao Huanyu [School of Automation, Nanjing University of Science and Technology, Nanjing 210094, Jiangsu (China); Chu Yuming [Department of Mathematics, Huzhou Teacher' s College, Huzhou 313000, Zhejiang (China)

    2010-05-17

    The problem of accelerating distributed average consensus by using the information of second-order neighbors in both the discrete- and continuous-time cases is addressed in this Letter. In both two cases, when the information of second-order neighbors is used in each iteration, the network will converge with a speed faster than the algorithm only using the information of first-order neighbors. Moreover, the problem of using partial information of second-order neighbors is considered, and the edges are not chosen randomly from second-order neighbors. In the continuous-time case, the edges are chosen by solving a convex optimization problem which is formed by using the convex relaxation method. In the discrete-time case, for small network the edges are chosen optimally via the brute force method. Finally, simulation examples are provided to demonstrate the effectiveness of the proposed algorithm.

  11. Top scientists join Stephen Hawking at Perimeter Institute

    Science.gov (United States)

    Banks, Michael

    2009-03-01

    Nine leading researchers are to join Stephen Hawking as visiting fellows at the Perimeter Institute for Theoretical Physics in Ontario, Canada. The researchers, who include string theorists Leonard Susskind from Stanford University and Asoka Sen from the Harisch-Chandra Research Institute in India, will each spend a few months of the year at the institute as "distinguished research chairs". They will be joined by another 30 scientists to be announced at a later date.

  12. ROMANIA'S MACROECONOMIC ACHIEVEMENTS FOR JOINING THE UNIQUE EUROPEAN CURENCY

    Directory of Open Access Journals (Sweden)

    SILVIA POPESCU

    2011-04-01

    Full Text Available The Romanian government has announced plans to join the eurozone by 2015. Currently, the leu is not yet part of ERM II but plans to join in 2010-2012. The economic advantages of the monetary union grow with expansion of the Euro zone. There is also a high level of skepticism; the main fear about the Euro is the inflation –that is considerable promoted by the Euro currency’s exchange rate in comparison with 2002; another restraint is due to member states inability to establish their own interest rates. The IMF arose the option of joining the Euro zone criteria relaxing. A one-sided Euro’s joining was suggested by International Monetary Fund on March-April 2009, in a confidential report mentioned by The Financial Times as the emergent states in Central and Eastern Europe to be able to pass to the unique currency, but not being represented in the Central European Bank Board. By its side, CEB considers that emergent states of the European Union must not pass to the unique currency unilaterally, because such a fact could under-mine the trust in Euro currency worldwide. This option would hardly deepen the macroeconomic controversies inside the Euro zone and would contradict the previous conditions already imposed. An acceptable solution could be the fastening of emergent countries joining the Exchange Rate Mechanism 2, after they are aware of risks arisen by such a step. The European Commission endorses in the Convergence Report on 2010 that Romania doesn’t meet any criteria needed by passing to the unique European currency, respectively: prices stability; budget position of the government; stability of exchange rate; interest convergence on long run and there are also law impediments. Our paper discusses arguments for a faster passing to the Euro currency versus arguments for a late joining the Euro currency in Romania.

  13. Molecular characterization and assessment of genetic diversity of ...

    African Journals Online (AJOL)

    R Madhusudhana

    genetic diversity available at molecular level among a set of phenotypically different ... allele matching and cluster analysis based on unweighted neighbor- joining (Gascuel, 1997) ..... on isozyme data-a simulation study. Theor. Appl. Genet.

  14. Drug safety data mining with a tree-based scan statistic.

    Science.gov (United States)

    Kulldorff, Martin; Dashevsky, Inna; Avery, Taliser R; Chan, Arnold K; Davis, Robert L; Graham, David; Platt, Richard; Andrade, Susan E; Boudreau, Denise; Gunter, Margaret J; Herrinton, Lisa J; Pawloski, Pamala A; Raebel, Marsha A; Roblin, Douglas; Brown, Jeffrey S

    2013-05-01

    In post-marketing drug safety surveillance, data mining can potentially detect rare but serious adverse events. Assessing an entire collection of drug-event pairs is traditionally performed on a predefined level of granularity. It is unknown a priori whether a drug causes a very specific or a set of related adverse events, such as mitral valve disorders, all valve disorders, or different types of heart disease. This methodological paper evaluates the tree-based scan statistic data mining method to enhance drug safety surveillance. We use a three-million-member electronic health records database from the HMO Research Network. Using the tree-based scan statistic, we assess the safety of selected antifungal and diabetes drugs, simultaneously evaluating overlapping diagnosis groups at different granularity levels, adjusting for multiple testing. Expected and observed adverse event counts were adjusted for age, sex, and health plan, producing a log likelihood ratio test statistic. Out of 732 evaluated disease groupings, 24 were statistically significant, divided among 10 non-overlapping disease categories. Five of the 10 signals are known adverse effects, four are likely due to confounding by indication, while one may warrant further investigation. The tree-based scan statistic can be successfully applied as a data mining tool in drug safety surveillance using observational data. The total number of statistical signals was modest and does not imply a causal relationship. Rather, data mining results should be used to generate candidate drug-event pairs for rigorous epidemiological studies to evaluate the individual and comparative safety profiles of drugs. Copyright © 2013 John Wiley & Sons, Ltd.

  15. Applying of Decision Tree Analysis to Risk Factors Associated with Pressure Ulcers in Long-Term Care Facilities.

    Science.gov (United States)

    Moon, Mikyung; Lee, Soo-Kyoung

    2017-01-01

    The purpose of this study was to use decision tree analysis to explore the factors associated with pressure ulcers (PUs) among elderly people admitted to Korean long-term care facilities. The data were extracted from the 2014 National Inpatient Sample (NIS)-data of Health Insurance Review and Assessment Service (HIRA). A MapReduce-based program was implemented to join and filter 5 tables of the NIS. The outcome predicted by the decision tree model was the prevalence of PUs as defined by the Korean Standard Classification of Disease-7 (KCD-7; code L89 * ). Using R 3.3.1, a decision tree was generated with the finalized 15,856 cases and 830 variables. The decision tree displayed 15 subgroups with 8 variables showing 0.804 accuracy, 0.820 sensitivity, and 0.787 specificity. The most significant primary predictor of PUs was length of stay less than 0.5 day. Other predictors were the presence of an infectious wound dressing, followed by having diagnoses numbering less than 3.5 and the presence of a simple dressing. Among diagnoses, "injuries to the hip and thigh" was the top predictor ranking 5th overall. Total hospital cost exceeding 2,200,000 Korean won (US $2,000) rounded out the top 7. These results support previous studies that showed length of stay, comorbidity, and total hospital cost were associated with PUs. Moreover, wound dressings were commonly used to treat PUs. They also show that machine learning, such as a decision tree, could effectively predict PUs using big data.

  16. Microwave joining of SiC

    Energy Technology Data Exchange (ETDEWEB)

    Silberglitt, R.; Ahmad, I. [FM Technologies, Inc., Fairfax, VA (United States); Black, W.M. [George Mason Univ., Fairfax, VA (United States)] [and others

    1995-05-01

    The purpose of this work is to optimize the properties of SiC-SiC joints made using microwave energy. The current focus is on optimization of time-temperature profiles, production of SiC from chemical precursors, and design of new applicators for joining of long tubes.

  17. TreeFam: a curated database of phylogenetic trees of animal gene families

    DEFF Research Database (Denmark)

    Li, Heng; Coghlan, Avril; Ruan, Jue

    2006-01-01

    TreeFam is a database of phylogenetic trees of gene families found in animals. It aims to develop a curated resource that presents the accurate evolutionary history of all animal gene families, as well as reliable ortholog and paralog assignments. Curated families are being added progressively......, based on seed alignments and trees in a similar fashion to Pfam. Release 1.1 of TreeFam contains curated trees for 690 families and automatically generated trees for another 11 646 families. These represent over 128 000 genes from nine fully sequenced animal genomes and over 45 000 other animal proteins...

  18. Why join the Staff Association

    CERN Multimedia

    Association du personnel

    2011-01-01

    Becoming a member of the Staff Association (SA) is above all a personal choice, showing that the joining person’s commitment and adherence to values such as solidarity, social cohesion, etc.In September, the SA launches a membership campaign to convince a maximum number to join, to inform, arouse interest and support. Posters, emails and individual contacts are part of the campaign programme, just like this editorial. As far as individual contacts are concerned, we ask you to give time and lend an ear to the delegates of your department in the Staff Council, who will approach you, in order to make an open and constructive discussion possible. Do not hesitate to ask questions and let them know your thoughts about the SA, as (constructive) criticism enables us to progress. The Staff Association and its role of collective representation The Staff Association, via its delegates, represents collectively all staff of the Organization before the Director-General and Member States. To do this, staff rep...

  19. Flexible Friction Stir Joining Technology

    Energy Technology Data Exchange (ETDEWEB)

    Feng, Zhili [Oak Ridge National Lab. (ORNL), Oak Ridge, TN (United States); Lim, Yong Chae [Oak Ridge National Lab. (ORNL), Oak Ridge, TN (United States); Mahoney, Murray [MegaStir Technologies LLC, Orem, UT (United States); Sanderson, Samuel [MegaStir Technologies LLC, Orem, UT (United States); Larsen, Steve [MegaStir Technologies LLC, Orem, UT (United States); Steel, Russel [MegaStir Technologies LLC, Orem, UT (United States); Fleck, Dale [MegaStir Technologies LLC, Orem, UT (United States); Fairchild, Doug P [ExxonMobil, Upstream Research Company (URC), Houston, TX (United States); Wasson, Andrew J [ExxonMobil, Upstream Research Company (URC), Houston, TX (United States); Babb, Jon [MegaStir Technologies LLC, Orem, UT (United States); Higgins, Paul [MegaStir Technologies LLC, Orem, UT (United States)

    2015-07-23

    Reported herein is the final report on a U.S. Department of Energy (DOE) Advanced Manufacturing Office (AMO) project with industry cost-share that was jointly carried out by Oak Ridge National Laboratory (ORNL), ExxonMobil Upstream Research Company (ExxonMobil), and MegaStir Technologies (MegaStir). The project was aimed to advance the state of the art of friction stir welding (FSW) technology, a highly energy-efficient solid-state joining process, for field deployable, on-site fabrications of large, complex and thick-sectioned structures of high-performance and high-temperature materials. The technology innovations developed herein attempted to address two fundamental shortcomings of FSW: 1) the inability for on-site welding and 2) the inability to weld thick section steels, both of which have impeded widespread use of FSW in manufacturing. Through this work, major advance has been made toward transforming FSW technology from a “specialty” process to a mainstream materials joining technology to realize its pervasive energy, environmental, and economic benefits across industry.

  20. Factors impacting stemflow generation in a European beech forest: Individual tree versus neighborhood properties

    Science.gov (United States)

    Metzger, Johanna Clara; Germer, Sonja; Hildebrandt, Anke

    2017-04-01

    The redistribution of precipitation by canopies changes the water flow dynamics to the forest floor. The spatial pattern of throughfall has been researched in a number of studies in different ecosystems. Yet, also stemflow substantially influences water input patterns, constituting a mean of 12% of gross precipitation for European beech as one of the most abundant tree species in Central Europe. While the initiation of stemflow depends mostly on precipitation event properties, stemflow amounts are strongly shaped by canopy structure. Stemflow research has mainly addressed the impact of single tree morphological variables. In previous studies, the impact of forest structure on area-based stemflow was studied comparing plots with different properties using few exemplary stemflow measurements. In non-homogeneous stands, this approach might not be accurate, as the variation of stand properties like tree density could change tree individual stemflow fluxes. To investigate this, a total measurement of all trees per plot is required. We hypothesize, that in addition to individual tree metrics, tree neighborhood relations have a significant impact on stemflow generation in a heterogeneous beech forest. Our study site is located in the pristine forest of the National Park Hainich, central Germany. It is heterogeneous in respect to tree density, species composition and tree age. We measured stemflow in an areal approach, for all trees on 11 subplots (each 10 m x 10 m) spaced evenly throughout a 1 ha plot. This involved overall 65 trees, which is 11% of the plot's trees. 27 precipitation events were recorded in spring and early summer of 2015 and 2016. Stand properties were surveyed, including diameter at breast height, height, position and species of a tree. From this data, we calculated neighborhood properties for each tree, as number, basal area, and relative height of neighboring trees within a radius of the plot's mean tree distance. Using linear mixed effects models, we