Geodesic Remeshing Using Front Propagation

Størrelse: px
Starte visningen fra side:

Download "Geodesic Remeshing Using Front Propagation"

Transkript

1 International Journal of Computer Vision 69(1), , 2006 c 2006 Springer Science + Business Media, LLC. Manufactured in The Netherlands. DOI: /s Geodesic Remeshing Using Front Propagation GABRIEL PEYRÉ CMAP, École Polytechnique, UMR CNRS 7641 peyre@cmapx.polytechnique.fr LAURENT D. COHEN CEREMADE, Université Paris Dauphine, UMR CNRS 7534 Place du Marechal de Lattre de Tassigny, Paris cedex 16, France cohen@ceremade.dauphine.fr Received April 12, 2004; Revised November 12, 2004; Accepted May 11, 2005 First online version published in May, 2006 Abstract. In this paper, we propose a complete framework for 3D geometry modeling and processing that uses only fast geodesic computations. The basic building block for these techniques is a novel greedy algorithm to perform a uniform or adaptive remeshing of a triangulated surface. Our other contributions include a parameterization scheme based on barycentric coordinates, an intrinsic algorithm for computing geodesic centroidal tessellations, and a fast and robust method to flatten a genus-0 surface patch. On large meshes (more than 500,000 vertices), our techniques speed up computation by over one order of magnitude in comparison to classical remeshing and parameterization methods. Our methods are easy to implement and do not need multilevel solvers to handle complex models that may contain poorly shaped triangles. Keywords: remeshing, geodesic computation, fast marching algorithm, mesh segmentation, surface parameterization, texture mapping, deformable models. 1. Introduction The applications of 3D geometry processing abound nowadays. They range from finite element computation to computer graphics, including solving all kinds of surface reconstruction problems. The most common representation of 3D objects is the triangle mesh, and the need for fast algorithms to handle this kind of geometry is obvious. Classical 3D triangulated manifold processing methods have several well known shortcomings: mainly, their high complexity when dealing with large meshes, and their numerical instabilities. To overcome these difficulties, we propose a geometry processing pipeline that relies on intrinsic information of the surface and not on its underlying triangulation. Borrowing from well established ideas in different fields (including image processing, perceptual learning, and finite element remeshing) we are able to process very large meshes efficiently Overview In Section 2 we introduce some concepts we use in our geodesic computations. This includes basic facts and some contributions about the Fast Marching algorithm and Voronoi diagrams on surfaces. In Section 3 we will expose a greedy algorithm for manifold sampling and remeshing, which iteratively adds points to find a mesh that has a uniform or adaptive distribution of vertices on the surface. Figure 1 shows some results of our remeshing procedure.

2 146 Peyré and Cohen In Section 4 we will expose two applications of our geodesic sampling strategy: the construction of a geodesic centroidal tesselation, and a fast flattening scheme. In Section 5 we will show the whole pipeline in action, and see how we can texture large meshes faster than current techniques would otherwise allow. We will then give a complete study of the timings of each part of our algorithm, including a comparison with classical methods Related Work Geodesic Computations. Distances computation on manifolds is a complex topic, and a lot of algorithms have been proposed such as Chen and Han shortest path method (Chen and Hahn, 1990) which is of quadratic complexity. Kimmel and Sethian s Fast Marching algorithm (Kimmel and Sethian, 1998) allows finding numerically the geodesic distance from a given point on the manifold, in O(n log(n)) in the number of vertices. They deduce minimal geodesics between two given points. Some direct applications of geodesic computations on manifolds have been proposed, such as in (Kimmel and Sethian, 2000), which applies the Fast Marching algorithm to obtain Voronoi diagram and offset curves on a manifold. Surface Remeshing. Huge 3D datasets often arise from surfaces reconstructed in medical imaging for exemple. This reconstruction task can be performed using algorithms from algorithmic geometry, e.g. (Delingette, 1999) or deformable models see (McInerney and Terzopoulos, 1996; Osher and Paragios, 2003). These 3D models can also be acquired from multiple stereo views, e.g. (Fua, 1997), or other industrial applications. These algorithms often produce meshes with a large amount of redundant vertices, and triangulations with poor quality. Thus these meshes must undergo a remeshing process. Remeshing methods roughly fall into two categories: Isotropic remeshing: a surface density of points is defined, and the algorithm tries to position the new vertices to match this density. For example the algorithm of Terzopoulos and Vasilescu (Terzopoulos and Vasilescu, 1992) uses dynamic models to perform the remeshing. Remeshing is also a basic task in the computer graphics community, and (Surazhsky et al., 2003) have proposed a procedure based on local parameterization. Anisotropic remeshing: the algorithm takes into account the principal directions of the surface to align locally the newly created triangles and/or rectangles. Finite element methods make heavy use of such remeshing algorithms (Kunert, 2002). The algorithm proposed in Alliez et al. (2003) uses lines of curvature to build a quad-dominant mesh. The importance of using geodesic information to perform this remeshing task is emphasized in Sifri et al. (2003). Ideas similar to our greedy solution for sampling a manifold (see Section 3.1) have been used with success in other fields such as computer vision (component grouping, (Cohen, 2001)), halftoning (void-and-cluster, (Ulichney, 1993)) and remeshing (Delaunay refinement, (Ruppert, 1995)). Figure 1. Remeshing of a 3D model using increasing weight for the speed function.

3 Geodesic Remeshing Using Front Propagation Geodesic-Based Building Blocks 2.1. Fast Marching Algorithm The classical Fast Marching algorithm is presented in Sethian (1999), and a similar algorithm was also proposed in Tsitsiklis (1995). This algorithm is used intensively in computer vision, for instance it has been applied to solve global minimization problems for deformable models (Cohen and Kimmel, 1997). This algorithm is formulated as follows. Suppose we are given a metric P(s)ds on some manifold such that P > 0. If we have two points x 0, x 1, the weighted geodesic distance between x 0 and x 1 is defined as d(x 0, x 1 ) def. = min γ ( 1 0 ) γ (t) P(γ (t))dt, (1) where γ is a piecewise regular curve with γ (0) = x 0 and γ (1) = x 1. When P = 1, the integral in (1) corresponds to the length of the curve γ and d is the classical geodesic distance. To compute the distance function U(x) def. = d(x 0, x) with an accurate and fast algorithm, this minimization can be reformulated as follows. The def. level set curve t ={x\u(x) = t} propagates following the evolution equation t (x) = 1 t P(x) nx, where n x is the exterior unit vector normal to the curve at x, and the function U satisfies the nonlinear Eikonal equation: U(x) = P(x). (2) The function F = 1/P > 0 can be interpreted as the propagation speed of the front t. The Fast Marching algorithm on an orthogonal grid makes use of an upwind finite difference scheme to compute the value u of U at a given point x i, j of a grid: max(u U(x i 1, j ), u U(x i+1, j ), 0) 2 + max(u U(x i, j 1 ), u U(x i, j+1 ), 0) 2 = h 2 P(x i, j ) 2. This is a second order equation that is solved as detailed for example in Cohen (2001). An optimal ordering of the grid points is chosen so that the whole computation only takes O(N log(n)), where N is the number of points. In Kimmel and Sethian (1998), a generalization to an arbitrary triangulation is proposed. This allows performing front propagations on a triangulated manifold, and computing geodesic distances with a fast and accurate algorithm. The only issue arises when the triangulation contains obtuse angles. The numerical scheme presented above is not monotone anymore, which can lead to numerical instabilities. To solve this problem, we follow (Kimmel and Sethian, 1998) who propose to unfold the triangles in a zone where we are sure that the update step will work. To get more accurate geodesic distance on meshes of bad quality, one can use higher order approximations, e.g. (Manay and Yezzi, 2003), which can be extended to triangulations using a local unfolding of each 1-ring. Figure 2 shows the calculation of a geodesic path computed using a gradient descent of the distance function Extraction of Voronoi Regions It is possible to start several fronts from points {x 1,..., x n } and make them evolve together, as shown on Fig. 3. The areas shown on the surface on the right define the Voronoi diagram of the starting Figure 2. Front Propagation (on the left), level sets of the distance function and geodesic paths (on the right).

4 148 Peyré and Cohen Figure 3. Progression of the fronts, Voronoi diagram, and resulting tessellation. points, namely the tessellation into the regions, for i {1,..., n} def. V i ={x \ j i, d(x, x j ) > d(x, x i )}. To accurately compute the boundaries of the Voronoi regions, we allow an overlap of the front on one vertex. Suppose a front a arrives at a vertex v 1 with time arrival t1 a and another front b arrives at a vertex v 2 (connected to v 1 ) with time t2 b. Allowing an overlap of the fronts, we record the time arrival t2 a of a at v 2, and t1 b of b at v 1. Then the two fronts meet at (1 λ)v 1 + λv 2 where λ = da 2 da 1 +db 1 db 2. d1 b da 1 3. Isotropic Remeshing of a Triangulation We proposed recently (Peyré and Cohen, 2003) a new method for sampling a 3D mesh that follows a farthest point strategy based on the weighted distance obtained through Fast Marching on the initial triangulation. This is related to the method introduced in Cohen (2001). A similar approach was proposed independently and simultaneously in Moenning and Dodgson (2003). It follows the farthest point strategy, introduced with success for image processing in Eldar et al. (1997) and related to the remeshing procedure of Chew (1993). Our approach iteratively adds new vertices based on the geodesic distance on the surface. The result of the algorithm gives a set of vertices uniformly distributed on the surface according to the geodesic distance. Taking into account a local density of vertices will be done in Sections 3.3 and A Greedy Algorithm for Uniformly Sampling a Manifold We now describe how to automatically build an evenly spaced set of points on a triangulated surface. A first point x 1 is chosen at random on the mesh and its geodesic distance map U 1 computed by fast marching. A more elaborate choice consists in replacing this random point by the point with maximum distance from it. Then we assume we have already computed a set of points S n = {x 1,..., x n }, together with U n the geodesic distance map to S n. To add a new point x n+1, we simply select a point on the manifold that is furthest away from S n, meaning that it has maximal value of U n. To compute the new distance map U n+1,weuse the fact that U n+1 = min(u n, U xn+1 ), where we have noted U xn+1 the distance map to x n+1. So we simply need to update U n by starting a front from x n+1 (using the Fast Marching algorithm exposed in Section 2) and to confine it on the set {x ; U xn+1 (x) U n (x)}. This assures that the whole remeshing process roughly takes less than O(N log(n) 2 ) operations. At each iteration, the new point x n+1 needs not to be a vertex of the original mesh. It can be positioned accurately by interpolating the distance map. To be more precise, it happens most often that the point with maximum distance is located in a triangle where three different fronts meet. We simply compute the intersection of each pair of fronts along each edge as it is described in Section 2.2. We then choose for x n+1 the center of mass of the three intersection points. We choose to stop the algorithm either when the last added point x n+1 satisfies U n (x n+1 ) δ, where δ is a given threshold, or when a given number of points have been distributed. Figure 4 shows the first steps of our algorithm on a square surface Calculation of the Geodesic Triangles Once we have found the complete set S n0, we must determine which vertices to link together to obtain our

5 Geodesic Remeshing Using Front Propagation 149 Figure 4. An overview of our greedy algorithm. Figure 5. Geodesic remeshing with an increasing number of points. new triangulation which is built incrementally during the algorithm. To that end, during the point distribution process we keep track of saddle points (see Cohen (2001)), which are vertices v that satisfy these two criterions: When the value of U(v) is set by the Fast Marching algorithm, two fronts coming from different base points x i and x j must meet for the first time at v (see Cohen (2001)). Adding edge [x i, x j ] to the new triangulation must keep the triangulation valid (e.g. the edge must have at most two adjacent faces). The set of saddle points tells us which vertices x i and x j should be linked together to obtain a valid triangulation. Note that when we update a distance map U n+1,a previously found saddle point v can disappear (if v is reached by the front coming from x n+1 ), and of course new saddle points can be created. Figure 5 shows progressive remeshing of the bunny and the David. In order to have a valid triangulation, the sampling of the manifold must be dense enough (for example 100 points is not enough to capture the geometry of the ears of the bunny). A theoretical proof of the validity of geodesic Delaunay triangulation can be found in Leibon and Letscher (2000), and more precise bound on the number of points is derived in Onishi and Itoh (2003). Note that our algorithm works with manifolds with boundaries, of arbitrary genus, and with multiple connected components.

6 150 Peyré and Cohen Figure 6. Adaptive remeshing: Iterative insertion of points in a square surface. Figure 7. Curvature-repulsive versus curvature-attractive sampling and remeshing Adaptive Remeshing 1 1+μ grad(i (x)), In the algorithm presented in Sections 3.1 and 3.2, the fronts propagate at a constant speed which results in uniformly spaced mesh. To introduce some adaptivity in the sampling performed by this algorithm, we use a speed function F = 1/P (which is the right hand side of the Eikonal equation) that is not constant across the surface. Figure 6 shows the progressive sampling of a square surface using a speed function with two different values. The colors show the level sets of the distance function U to the set of selected points. Since vertices are added at maximal values of the geodesic weighted distance, the resulting mesh will be dense in regions with smaller F, and in regions with higher F the mesh will be sparse. This is due to the fact that the algorithm distributes points in such a way that their weighted geodesic distances to neighbors are almost equal. The geodesic distance to vertices in a region with higher value of P is thus smaller. Function F can reflect the need of the user to refine some specific regions with more vertices. To illustrate our approach, we give an example of a mesh obtained from range scanning. A picture I of the model can be mapped onto the 3D mesh. Using a function F of the form F(x) = where μ is a user-defined constant, one can refine regions with high variations in intensity. On figure 1, one can see a 3D head remeshed with various μ ranging from μ = 0 (uniform) to μ = 20/ max( grad(i (x)) ) (highly adaptive) Curvature-Based Remeshing The local density of vertices can also reflect some geometric properties of the surface. The most natural choice is to adapt the mesh in order to be finer in regions where the local curvature is larger. The evaluation of the curvature tensor is a vast topic. We used a robust construction proposed recently in Cohen-Steiner and Morvan (2003). Let us denote by τ(x) def. = λ 1 + λ 2 the total curvature at a given point x of the surface, where λ i are the eigenvalues of the second fundamental form. We can introduce two speed functions F 1 (x) def. = 1 + ετ(x) and F 2 (x) def. 1 =, where ε and μ are two user-defined 1+μτ(x) parameters. Figure 7(a) shows that by using function F 1, we avoid putting more vertices in regions of the surface with high curvature. The speed function F 1 can be interpreted as an edge repulsive function. On the other hand, function F 2 could be called edge attractive function, since it forces the sampling to put more vertices in region with high curvature such as mesh corners and edges. Figure 7(b) shows that this speed function leads to very good results for the remeshing

7 Geodesic Remeshing Using Front Propagation 151 Figure 8. Different steps in mesh parameterization: from left to right original mesh, automatic determination of basis points, determination of associated Delaunay triangulation, calculation of the corresponding geodesic triangles, parameterization interpolation, semi-regular remeshing. of a surface with sharp features, which is obviously not the case for the edge repulsive speed function (Fig. 7(a)). 4. Applications to Mesh Parameterization, Segmentation and Flattening 4.1. Mesh Parameterization In Peyré and Cohen (2003) we proposed a simple scheme to parameterize an arbitrary triangulated manifold using a coarse triangulation as base domain. This coarse version of the mesh is built using our geodesic remeshing. The parameterization on each corresponding geodesic triangle of the original mesh is built with a geodesic extension of the barycentric coordinates that makes use of Heron formula. The resulting parameterization is smooth on each triangle of the base domain, and only continuous across the geodesic edges (much more complex method have to be used to get globally smooth parameterization, see (Khodakovsky et al., 2003)). It can be used to build a semi-regular mesh, as shown on Fig. 8, and a simple relaxation scheme can be used to regularize vertices location near the boundaries of geodesic triangles (see (Lee et al., 1998)) Mesh Segmentation Using Centroidal Tessellation In Peyré and Cohen (2004b) we have proposed an automatic mesh segmentation method very well adapted to the tessellation of a complex manifold in elementary domains topologically equivalent to a disk. In this method the mesh is cut into regions that best satisfy the following properties: (C1) Boundaries of the regions agree with sharp features of the surface. (C2) Regions are as compact as possible (the ratio area/perimeter should be large), enclosing equal areas. The goal of the algorithm is to build a segmentation = n i=1 V i of a triangulated manifold. The V i will be the Voronoi regions associated with a given set of points {v 1,...,v n }. Initially, these points are chosen using the sampling algorithm of Section 3.1. Then a geodesic extension of Lloyd algorithm will refine the location of the v i so that they agree with the geodesic center of mass of each region V i. Figure 9 shows some iterations of the Lloyd relaxation scheme, and we obtain a geodesic bee-hive segmentation. At each iteration, the center of mass of each region is computed using a gradient descent of the energy E i (w) def. = d(x, w) 2 ds. x V i where ds is the area element on the surface and d is the geodesic distance. In order to force the boundaries of the regions V i to follow the discontinuities of the surface, we use the edge attractive speed function F 2 (v) defined in Section 3.4. This will allow us to freeze the front in regions with high curvature. This way the resulting Voronoi regions will have boundaries aligned with sharp features of the surface, and condition (C1) will be satisfied. Figure 10 shows the segmentation we obtain on complex models. In the close-up we can see that the cell boundaries try to follow the edges of the mesh whenever it is possible. Following the ideas of the Section 3.3, we can use a texture function to modulate the speed function. The resulting segmentation can take into account both the texture intensity and the curvature information, according to the user will. Figure 11 shows the segmentation of a texture computed directly on the triangulated mesh (which can have arbitrary topology). The segmented function on the right is the speed function represented on the 2D parameter space together with the boundaries of the Voronoi cells.

8 152 Peyré and Cohen Figure 9. Lloyd iterations on various models. Figure 10. Segmentation of two complex models. Figure 11. Segmentation of a textured head Fast Geodesic Flattening In Peyré and Cohen (2004a) we have proposed a method for flattening a triangulated manifold. This method is very fast and in contrast to traditional methods (see Floater et al. (2002) for a complete survey, and (Gu and Yau, 2003; Khodakovsky et al., 2003) for more complex and global schemes), it does not

9 Geodesic Remeshing Using Front Propagation 153 Figure 12. Flattening: influence of the number of base points. The original model is shown on the left of Fig. 13. Figure 13. From left to right, the original model, texture on the flattened domain, and on the 3D mesh. require the solution of a large and ill-conditioned linear system. Recently, some nonlinear algorithms for dimensionality reduction have appeared in the community of perceptual manifold learning. The most notable are IsoMap (Tenenbaum et al., 2000) and Locally Linear Embedding (LLE) (Roweis and Saul, 2000). The multidimensional scaling approach to flattening of Zigelman et al. (2002) is closely related to IsoMap. In order to speed-up the computation and to achieve a local control over the flattening, we have extended the classical LLE approach to the geodesic setting. Our procedure can be used to flatten a small set of points (chosen using the greedy procedure presented in Section 3.1). We then extend the mapping to the whole mesh using a Nyström integral relation, as already proposed in Bengio et al. (2003). Figure 13 shows the extension of the flattening from this small set of points and figure 13 shows the influence of the number of points. We can then use the resulting mapping to perform texture mapping, see Fig Results and Discussion Uniform remeshing. To show the improvement of the quality of the mesh that our uniform remeshing algorithm can bring, we report in Table 1 the average angle of the triangulation together with the standard deviation of the angle repartition. Adaptive remeshing. To study the behavior of our isotropic remeshing as an approximation procedure, we measure the mean-square Hausdorf distance between the original mesh and a coarse version produced by our method. We also compare the distortion result of our scheme with another greedy procedure, the progres- Table 1. Average and standard deviation of the angle distribution. David (Fig. 5) Feline (Fig. 10) Bunny (Fig. 5) Fandisk (Fig. 10) (700k vert.) (50k vert.) (35k vert.) (6500 vert.) Original 54 (± 8 ) 60 (± 7 ) 59 (± 6 ) 57 (± 8 ) Remeshing (10% #verts) 58 (± 2 ) 60.5 (± 2.5 ) 61 (± 4 ) 59 (± 4 ) Remeshing (30% #verts) 59 (± 2 ) 61 (± 2 ) 60 (± 3.5 ) 59 (± 3 )

10 154 Peyré and Cohen Figure 14. Remeshing error. Left: distorsion curve, right: graphic display of the location of the error. Figure 15. Texturing of the feline model. Figure 16. An overview of our pipeline. The mesh is first segmented using a weighted geodesic centroidal tessellation. Each resulting patch is then flattened using the Geodesic LLE procedure. At last, we can perform texture mapping on each base domain. sive mesh (Hoppe, 1996). On the left of Fig. 14 one can see the decreasing of the error with the number of vertices, and on the right a display of the location of the error. This clearly shows the strength of our scheme for models with sharp features. Texturing of a Complex Model. On Figs. 15 and 16 one can see the whole pipeline in action. This includes first a centroidal tessellation of the mesh, then the extraction and flattening of each cell, and lastly the texturing of the model. Computation Times. Table 2 shows the complexity of the algorithms mentioned in the paper. The constant A is the number of steps in the gradient descent for the localization of the intrinsic center of mass, which is about A = 8 for 10 k vertices. The constant B represent

11 Geodesic Remeshing Using Front Propagation 155 Table 2. Complexity of the algorithms. F. Marching Greedy sampling 1 Lloyd iter. Zigelman02 Geodesic LLE Complexity n log(n) n log(n) 2 An log(n) Bn log(n) + B 3 n log(n) + B 2 Times (10k vert.) 2s 10s 6s 55s 28s the number of base points, which is 100 in our tests. This clearly shows the speed up that Geodesic LLE can bring over global methods such as Zigelman et al. (2002). On a mesh of 700k vertices, the whole pipeline (i.e. segmentation, sampling and flattening) takes 740s for Geodesic LLE, 1320s for the classical method of Desbrun et al. (2002) and several hours for Zigelman et al. (2002). Our future works include a theoretical study of the quality of the embedding given by our algorithms. We also would like to analyze experimentally the quality of the whole pipeline. A good way of evaluating the efficiency of such a scheme is to use its output to perform mesh compression. The mesh atlas provided by our algorithm is an ideal pre-processing step for performing wavelet transform in parameter space, in a fashion similar to Sander et al. (2003). 6. Conclusion We have described a complete pipeline for 3D mesh resampling, segmentation and flattening. The main tool that allows to have a fast algorithm is the fast marching on a triangulated mesh, together with some improvements we added. We introduced a fast algorihtm for remeshing of a surface with a uniform or adaptive distribution. This is based on iteratively choosing the farthest point according to a weighted distance on the surface. The first stage of the pipeline is the segmentation of the mesh into a set of genus-0 patches. Our contribution there includes a geodesic extension of the Lloyd algorithm that is able to construct a geodesic centroidal tessellation. This iterative algorithm takes into account curvature information of the surface and is very well suited to building a set of base domains for mesh flattening. The second stage of our pipeline is a geodesic flattening procedure. We introduced a geodesic version of Locally Linear Embedding that is able to perform fast computations on a given set of points, and to extend the embedding to the rest of the mesh in a transparent manner. The resulting flattening is smooth and achieves a desirable trade-off between conservation of angle and area. References Alliez, P., Cohen-Steiner, D., Devillers, O., Levy, B., and Desbrun, M Anisotropic Polygonal Remeshing. ACM Transactions on Graphics. Special Issue for SIGGRAPH Conference, pp Bengio, Y., Paiement, J.-F., and Vincent, P Out-of-Sample Extensions for LLE, Isomap, MDS, Eigenmaps, and Spectral Clustering. Proc. NIPS, Chen, J. and Hahn, Y Shortest Path on a Polyhedron. Proc. 6th ACM Sympos, Comput Geom pp Chew, L.P Guaranteed-Quality Mesh Generation for Curved Surfaces. In Proc. of the Ninth Symposium on Computational Geometry, pp Cohen, L Multiple contour finding and perceptual grouping using minimal paths. Journal of Mathematical Imaging and Vision, 14(3): Cohen, L.D. and Kimmel, R Global minimum for active contour models: A minimal path approach. International Journal of Computer Vision 24(1): Cohen-Steiner, D. and Morvan, J.-M Restricted delaunay triangulations and normal cycles. In Proc. 19th ACM Sympos, Comput. Geom. pp Delingette, H General object reconstruction based on simplex meshes. International Journal of Computer Vision, 32(2): Desbrun, M., Meyer, M., and Alliez, P Intrinsic parameterizations of surface meshes. Eurographics Conference Proceedings, 21(2): Eldar, Y., Lindenbaum, M., Porat, M., and Zeevi, Y The farthest point strategy for progressive image sampling. IEEE Trans. on Image Processing, 6(9): Floater, M.S., Hormann, K., and Reimers, M Parameterization of manifold triangulations. Approximation Theory X: Abstract and Classical Analysis, pp Fua, P From multiple stereo views to multiple 3-D Surfaces. International Journal of Computer Vision, 24(1): Gu, X. and Yau, S.-T Global conformal surface parameterization. In Proc. ACM Symposium on Geometry Processing, 2003 pp Hoppe, H Progressive meshes. In Proc. ACM SIGGRAPH 1996 pp Khodakovsky, A., Litke, N., and Schröder, P Globally smooth parameterizations with low distortion. ACM Transactions on Graphics. Special Issue for SIGGRAPH Conference, pp Kimmel, R. and Sethian, J Computing geodesic paths on manifolds. Proc. Natl. Acad. Sci., 95(15): Kimmel, R. and Sethian, J.A Fast voronoi diagrams on triangulated surfaces. In Proc. of the 16th European Workshop on Comp. Geom., (EUROCG-00). pp. 1 4.

12 156 Peyré and Cohen Kunert, G Towards anisotropic mesh construction and error estimation in the finite element method. Numerical Methods in PDE, 18: Lee, A.W.F., Schröder, P., Sweldens, W., Cowsar, L., and Dobkin, D MAPS: Multiresolution adaptive parameterization of surfaces. Computer Graphics 32(Ann. Conf. Series), Leibon, G. and Letscher, D Delaunay triangulations and voronoi diagrams for riemannian manifolds. ACM Symposium on Computational Geometry, pp Manay, S. and Yezzi, A Second-order models for computing distance transforms. In Proc. IEEE Variational, Geometric and Level Set Methods 2003, pp McInerney, T. and Terzopoulos, D Deformable models in medical image analysis: A survey. Medical Image Analysis 1(2): Moenning, C. and Dodgson, N.A Fast marching farthest point sampling. In Proc. EURO-GRAPHICS, Onishi, K. and Itoh, J Estimation of the necessary number of points in Riemannian Voronoi diagram. In Proc. CCCG 2003, pp Osher, S. and Paragios, N Geometric Level Set Methods in Imaging, Vision, and Graphics. Springer-Verlag New York, Inc. Peyré, G. and Cohen, L.D Geodesic remeshing using front propagation. In Proc. IEEE Variational, Geometric and Level Set Methods 2003, pp Peyré, G. and Cohen, L.D. 2004a. Geodesic computations for fast and accurate surface flattening. Preprint CMAP. Peyré, G. and Cohen, L.D. 2004b. Surface Segmentation Using Geodesic Centroidal Tesselation. In Proc. IEEE 3D Data Processing Visualization Transmission 2004, pp Roweis, S. and Saul, L Nonlinear dimensionality reduction by locally linear embedding. Science, 290(5500): Ruppert, J A delaunay refinement algorithm for quality 2- Dimensional mesh generation. Journal of Algorithms, 18(3): Sander, P., Wood, Z., Gortler, S., Snyder, J., and Hoppe, H Multi-chart geometry images. Proc. Symposium on Geometry Processing 2003 pp Sethian, J Level Sets Methods and Fast Marching Methods. 2nd edition, Cambridge University Press. Sifri, O., Sheffer, A., and Gotsman, C Geodesic-based surface remeshing. In Proc. 12th International Meshing Roundtable, pp Surazhsky, V., Alliez, P., and Gotsman, C Isotropic remeshing of surfaces: A Local Parameter-ization Approach. In Proc. 12th International Meshing Roundtable. Tenenbaum, J.B., de Silva, V., and Langford, J.C A global geometric framework for nonlinear dimensionality reduction. Science, 290(5500): Terzopoulos, D. and Vasilescu, M Adaptive meshes and shells: Irregular triangulation, dis-continuities, and hierarchical subdivision. In Proc. IEEE CVPR 92. Champaign, Illinois, pp Tsitsiklis, J Efficient algorithms for globally optimal trajectories. IEEE Trans. on Automatic Control. Ulichney, R The void-and-cluster method for generating dither arrays. Proc. IS&T Symposium on Electronic Imaging Science & Technology, San Jose, CA 1913(9): Zigelman, G., Kimmel, R., and Kiryati, N Texture mapping using surface flattening via multi-dimensional scaling. IEEE Trans. on Visualization and Computer Graphics, 8(1):

Particle-based T-Spline Level Set Evolution for 3D Object Reconstruction with Range and Volume Constraints

Particle-based T-Spline Level Set Evolution for 3D Object Reconstruction with Range and Volume Constraints Particle-based T-Spline Level Set for 3D Object Reconstruction with Range and Volume Constraints Robert Feichtinger (joint work with Huaiping Yang, Bert Jüttler) Institute of Applied Geometry, JKU Linz

Læs mere

Generalized Probit Model in Design of Dose Finding Experiments. Yuehui Wu Valerii V. Fedorov RSU, GlaxoSmithKline, US

Generalized Probit Model in Design of Dose Finding Experiments. Yuehui Wu Valerii V. Fedorov RSU, GlaxoSmithKline, US Generalized Probit Model in Design of Dose Finding Experiments Yuehui Wu Valerii V. Fedorov RSU, GlaxoSmithKline, US Outline Motivation Generalized probit model Utility function Locally optimal designs

Læs mere

Basic statistics for experimental medical researchers

Basic statistics for experimental medical researchers Basic statistics for experimental medical researchers Sample size calculations September 15th 2016 Christian Pipper Department of public health (IFSV) Faculty of Health and Medicinal Science (SUND) E-mail:

Læs mere

Black Jack --- Review. Spring 2012

Black Jack --- Review. Spring 2012 Black Jack --- Review Spring 2012 Simulation Simulation can solve real-world problems by modeling realworld processes to provide otherwise unobtainable information. Computer simulation is used to predict

Læs mere

PARALLELIZATION OF ATTILA SIMULATOR WITH OPENMP MIGUEL ÁNGEL MARTÍNEZ DEL AMOR MINIPROJECT OF TDT24 NTNU

PARALLELIZATION OF ATTILA SIMULATOR WITH OPENMP MIGUEL ÁNGEL MARTÍNEZ DEL AMOR MINIPROJECT OF TDT24 NTNU PARALLELIZATION OF ATTILA SIMULATOR WITH OPENMP MIGUEL ÁNGEL MARTÍNEZ DEL AMOR MINIPROJECT OF TDT24 NTNU OUTLINE INEFFICIENCY OF ATTILA WAYS TO PARALLELIZE LOW COMPATIBILITY IN THE COMPILATION A SOLUTION

Læs mere

Project Step 7. Behavioral modeling of a dual ported register set. 1/8/ L11 Project Step 5 Copyright Joanne DeGroat, ECE, OSU 1

Project Step 7. Behavioral modeling of a dual ported register set. 1/8/ L11 Project Step 5 Copyright Joanne DeGroat, ECE, OSU 1 Project Step 7 Behavioral modeling of a dual ported register set. Copyright 2006 - Joanne DeGroat, ECE, OSU 1 The register set Register set specifications 16 dual ported registers each with 16- bit words

Læs mere

Privat-, statslig- eller regional institution m.v. Andet Added Bekaempelsesudfoerende: string No Label: Bekæmpelsesudførende

Privat-, statslig- eller regional institution m.v. Andet Added Bekaempelsesudfoerende: string No Label: Bekæmpelsesudførende Changes for Rottedatabasen Web Service The coming version of Rottedatabasen Web Service will have several changes some of them breaking for the exposed methods. These changes and the business logic behind

Læs mere

Linear Programming ١ C H A P T E R 2

Linear Programming ١ C H A P T E R 2 Linear Programming ١ C H A P T E R 2 Problem Formulation Problem formulation or modeling is the process of translating a verbal statement of a problem into a mathematical statement. The Guidelines of formulation

Læs mere

Sampling real algebraic varieties for topological data analysis

Sampling real algebraic varieties for topological data analysis Sampling real algebraic varieties for topological data analysis Joint with: Emilie Dufresne (U. York) Heather Harrington (U. Oxford) Jonathan Hauenstein (U. Notre Dame) AG19, July 2019 Sampling real varieties

Læs mere

Portal Registration. Check Junk Mail for activation . 1 Click the hyperlink to take you back to the portal to confirm your registration

Portal Registration. Check Junk Mail for activation  . 1 Click the hyperlink to take you back to the portal to confirm your registration Portal Registration Step 1 Provide the necessary information to create your user. Note: First Name, Last Name and Email have to match exactly to your profile in the Membership system. Step 2 Click on the

Læs mere

The complete construction for copying a segment, AB, is shown above. Describe each stage of the process.

The complete construction for copying a segment, AB, is shown above. Describe each stage of the process. A a compass, a straightedge, a ruler, patty paper B C A Stage 1 Stage 2 B C D Stage 3 The complete construction for copying a segment, AB, is shown above. Describe each stage of the process. Use a ruler

Læs mere

The GAssist Pittsburgh Learning Classifier System. Dr. J. Bacardit, N. Krasnogor G53BIO - Bioinformatics

The GAssist Pittsburgh Learning Classifier System. Dr. J. Bacardit, N. Krasnogor G53BIO - Bioinformatics The GAssist Pittsburgh Learning Classifier System Dr. J. Bacardit, N. Krasnogor G53BIO - Outline bioinformatics Summary and future directions Objectives of GAssist GAssist [Bacardit, 04] is a Pittsburgh

Læs mere

Curve Modeling B-Spline Curves. Dr. S.M. Malaek. Assistant: M. Younesi

Curve Modeling B-Spline Curves. Dr. S.M. Malaek. Assistant: M. Younesi Curve Modeling B-Spline Curves Dr. S.M. Malaek Assistant: M. Younesi Motivation B-Spline Basis: Motivation Consider designing the profile of a vase. The left figure below is a Bézier curve of degree 11;

Læs mere

On the complexity of drawing trees nicely: corrigendum

On the complexity of drawing trees nicely: corrigendum Acta Informatica 40, 603 607 (2004) Digital Object Identifier (DOI) 10.1007/s00236-004-0138-y On the complexity of drawing trees nicely: corrigendum Thorsten Akkerman, Christoph Buchheim, Michael Jünger,

Læs mere

Sign variation, the Grassmannian, and total positivity

Sign variation, the Grassmannian, and total positivity Sign variation, the Grassmannian, and total positivity arxiv:1503.05622 Slides available at math.berkeley.edu/~skarp Steven N. Karp, UC Berkeley FPSAC 2015 KAIST, Daejeon Steven N. Karp (UC Berkeley) Sign

Læs mere

Exercise 6.14 Linearly independent vectors are also affinely independent.

Exercise 6.14 Linearly independent vectors are also affinely independent. Affine sets Linear Inequality Systems Definition 6.12 The vectors v 1, v 2,..., v k are affinely independent if v 2 v 1,..., v k v 1 is linearly independent; affinely dependent, otherwise. We first check

Læs mere

Introduction Ronny Bismark

Introduction Ronny Bismark Introduction 1 Outline Motivation / Problem Statement Tool holder Sensor calibration Motion primitive Concatenation of clouds Segmentation Next possible pose Problems and Challenges Future Work 2 Motivation

Læs mere

IBM Network Station Manager. esuite 1.5 / NSM Integration. IBM Network Computer Division. tdc - 02/08/99 lotusnsm.prz Page 1

IBM Network Station Manager. esuite 1.5 / NSM Integration. IBM Network Computer Division. tdc - 02/08/99 lotusnsm.prz Page 1 IBM Network Station Manager esuite 1.5 / NSM Integration IBM Network Computer Division tdc - 02/08/99 lotusnsm.prz Page 1 New esuite Settings in NSM The Lotus esuite Workplace administration option is

Læs mere

Skriftlig Eksamen Kombinatorik, Sandsynlighed og Randomiserede Algoritmer (DM528)

Skriftlig Eksamen Kombinatorik, Sandsynlighed og Randomiserede Algoritmer (DM528) Skriftlig Eksamen Kombinatorik, Sandsynlighed og Randomiserede Algoritmer (DM58) Institut for Matematik og Datalogi Syddansk Universitet, Odense Torsdag den 1. januar 01 kl. 9 13 Alle sædvanlige hjælpemidler

Læs mere

Engelsk. Niveau C. De Merkantile Erhvervsuddannelser September 2005. Casebaseret eksamen. www.jysk.dk og www.jysk.com.

Engelsk. Niveau C. De Merkantile Erhvervsuddannelser September 2005. Casebaseret eksamen. www.jysk.dk og www.jysk.com. 052430_EngelskC 08/09/05 13:29 Side 1 De Merkantile Erhvervsuddannelser September 2005 Side 1 af 4 sider Casebaseret eksamen Engelsk Niveau C www.jysk.dk og www.jysk.com Indhold: Opgave 1 Presentation

Læs mere

Applications. Computational Linguistics: Jordan Boyd-Graber University of Maryland RL FOR MACHINE TRANSLATION. Slides adapted from Phillip Koehn

Applications. Computational Linguistics: Jordan Boyd-Graber University of Maryland RL FOR MACHINE TRANSLATION. Slides adapted from Phillip Koehn Applications Slides adapted from Phillip Koehn Computational Linguistics: Jordan Boyd-Graber University of Maryland RL FOR MACHINE TRANSLATION Computational Linguistics: Jordan Boyd-Graber UMD Applications

Læs mere

Besvarelser til Lineær Algebra Reeksamen Februar 2017

Besvarelser til Lineær Algebra Reeksamen Februar 2017 Besvarelser til Lineær Algebra Reeksamen - 7. Februar 207 Mikkel Findinge Bemærk, at der kan være sneget sig fejl ind. Kontakt mig endelig, hvis du skulle falde over en sådan. Dette dokument har udelukkende

Læs mere

v Motivation v Multi- Atlas Segmentation v Learn Dictionary v Apply Dictionary v Results

v Motivation v Multi- Atlas Segmentation v Learn Dictionary v Apply Dictionary v Results Anatomical Atlas Probabilistic Atlas Shattuck, et al. NeuroImage. 2008 v Motivation v Multi- Atlas Segmentation v Learn Dictionary v Apply Dictionary v Results 2 Shattuck, et al. NeuroImage. 2008 Traditional

Læs mere

Engelsk. Niveau D. De Merkantile Erhvervsuddannelser September Casebaseret eksamen. og

Engelsk. Niveau D. De Merkantile Erhvervsuddannelser September Casebaseret eksamen.  og 052431_EngelskD 08/09/05 13:29 Side 1 De Merkantile Erhvervsuddannelser September 2005 Side 1 af 4 sider Casebaseret eksamen Engelsk Niveau D www.jysk.dk og www.jysk.com Indhold: Opgave 1 Presentation

Læs mere

Resource types R 1 1, R 2 2,..., R m CPU cycles, memory space, files, I/O devices Each resource type R i has W i instances.

Resource types R 1 1, R 2 2,..., R m CPU cycles, memory space, files, I/O devices Each resource type R i has W i instances. System Model Resource types R 1 1, R 2 2,..., R m CPU cycles, memory space, files, I/O devices Each resource type R i has W i instances. Each process utilizes a resource as follows: request use e.g., request

Læs mere

Vina Nguyen HSSP July 13, 2008

Vina Nguyen HSSP July 13, 2008 Vina Nguyen HSSP July 13, 2008 1 What does it mean if sets A, B, C are a partition of set D? 2 How do you calculate P(A B) using the formula for conditional probability? 3 What is the difference between

Læs mere

Aktivering af Survey funktionalitet

Aktivering af Survey funktionalitet Surveys i REDCap REDCap gør det muligt at eksponere ét eller flere instrumenter som et survey (spørgeskema) som derefter kan udfyldes direkte af patienten eller forsøgspersonen over internettet. Dette

Læs mere

CHAPTER 8: USING OBJECTS

CHAPTER 8: USING OBJECTS Ruby: Philosophy & Implementation CHAPTER 8: USING OBJECTS Introduction to Computer Science Using Ruby Ruby is the latest in the family of Object Oriented Programming Languages As such, its designer studied

Læs mere

ECE 551: Digital System * Design & Synthesis Lecture Set 5

ECE 551: Digital System * Design & Synthesis Lecture Set 5 ECE 551: Digital System * Design & Synthesis Lecture Set 5 5.1: Verilog Behavioral Model for Finite State Machines (FSMs) 5.2: Verilog Simulation I/O and 2001 Standard (In Separate File) 3/4/2003 1 ECE

Læs mere

A multimodel data assimilation framework for hydrology

A multimodel data assimilation framework for hydrology A multimodel data assimilation framework for hydrology Antoine Thiboult, François Anctil Université Laval June 27 th 2017 What is Data Assimilation? Use observations to improve simulation 2 of 8 What is

Læs mere

Central Statistical Agency.

Central Statistical Agency. Central Statistical Agency www.csa.gov.et 1 Outline Introduction Characteristics of Construction Aim of the Survey Methodology Result Conclusion 2 Introduction Meaning of Construction Construction may

Læs mere

Observation Processes:

Observation Processes: Observation Processes: Preparing for lesson observations, Observing lessons Providing formative feedback Gerry Davies Faculty of Education Preparing for Observation: Task 1 How can we help student-teachers

Læs mere

Unitel EDI MT940 June 2010. Based on: SWIFT Standards - Category 9 MT940 Customer Statement Message (January 2004)

Unitel EDI MT940 June 2010. Based on: SWIFT Standards - Category 9 MT940 Customer Statement Message (January 2004) Unitel EDI MT940 June 2010 Based on: SWIFT Standards - Category 9 MT940 Customer Statement Message (January 2004) Contents 1. Introduction...3 2. General...3 3. Description of the MT940 message...3 3.1.

Læs mere

Kurver og flader Aktivitet 15 Geodætiske kurver, Isometri, Mainardi-Codazzi, Teorema Egregium

Kurver og flader Aktivitet 15 Geodætiske kurver, Isometri, Mainardi-Codazzi, Teorema Egregium Kurver og flader Aktivitet 15 Geodætiske kurver, Isometri, Mainardi-Codazzi, Teorema Egregium Lisbeth Fajstrup Institut for Matematiske Fag Aalborg Universitet Kurver og Flader 2013 Lisbeth Fajstrup (AAU)

Læs mere

Løsning af skyline-problemet

Løsning af skyline-problemet Løsning af skyline-problemet Keld Helsgaun RUC, oktober 1999 Efter at have overvejet problemet en stund er min første indskydelse, at jeg kan opnå en løsning ved at tilføje en bygning til den aktuelle

Læs mere

Skriftlig Eksamen Diskret matematik med anvendelser (DM72)

Skriftlig Eksamen Diskret matematik med anvendelser (DM72) Skriftlig Eksamen Diskret matematik med anvendelser (DM72) Institut for Matematik & Datalogi Syddansk Universitet, Odense Onsdag den 18. januar 2006 Alle sædvanlige hjælpemidler (lærebøger, notater etc.),

Læs mere

Det Teknisk-Naturvidenskabelige Fakultet Første Studieår AALBORG UNIVERSITET Arkitektur Og Design MATEMATIK OG FORM

Det Teknisk-Naturvidenskabelige Fakultet Første Studieår AALBORG UNIVERSITET Arkitektur Og Design MATEMATIK OG FORM Det Teknisk-Naturvidenskabelige Fakultet Første Studieår AALBORG UNIVERSITET Arkitektur Og Design MATEMATIK OG FORM 27 April 2012 - Lecture 4 (in English) Vector operations in Grasshopper Group 1 8:15-9:15

Læs mere

Skriftlig Eksamen Beregnelighed (DM517)

Skriftlig Eksamen Beregnelighed (DM517) Skriftlig Eksamen Beregnelighed (DM517) Institut for Matematik & Datalogi Syddansk Universitet Mandag den 31 Oktober 2011, kl. 9 13 Alle sædvanlige hjælpemidler (lærebøger, notater etc.) samt brug af lommeregner

Læs mere

Design til digitale kommunikationsplatforme-f2013

Design til digitale kommunikationsplatforme-f2013 E-travellbook Design til digitale kommunikationsplatforme-f2013 ITU 22.05.2013 Dreamers Lana Grunwald - svetlana.grunwald@gmail.com Iya Murash-Millo - iyam@itu.dk Hiwa Mansurbeg - hiwm@itu.dk Jørgen K.

Læs mere

Brug sømbrættet til at lave sjove figurer. Lav fx: Få de andre til at gætte, hvad du har lavet. Use the nail board to make funny shapes.

Brug sømbrættet til at lave sjove figurer. Lav fx: Få de andre til at gætte, hvad du har lavet. Use the nail board to make funny shapes. Brug sømbrættet til at lave sjove figurer. Lav f: Et dannebrogsflag Et hus med tag, vinduer og dør En fugl En bil En blomst Få de andre til at gætte, hvad du har lavet. Use the nail board to make funn

Læs mere

Differential Evolution (DE) "Biologically-inspired computing", T. Krink, EVALife Group, Univ. of Aarhus, Denmark

Differential Evolution (DE) Biologically-inspired computing, T. Krink, EVALife Group, Univ. of Aarhus, Denmark Differential Evolution (DE) Differential Evolution (DE) (Storn and Price, 199) Step 1 - Initialize and evaluate Generate a random start population and evaluate the individuals x 2 search space x 1 Differential

Læs mere

Learnings from the implementation of Epic

Learnings from the implementation of Epic Learnings from the implementation of Epic Appendix Picture from Region H (2016) A thesis report by: Oliver Metcalf-Rinaldo, oliv@itu.dk Stephan Mosko Jensen, smos@itu.dk Appendix - Table of content Appendix

Læs mere

Fast Surface Segmentation Guided by User Input Using Implicit Extension of Minimal Paths

Fast Surface Segmentation Guided by User Input Using Implicit Extension of Minimal Paths J Math Imaging Vis 25: 289 305, 2006 c 2006 Springer Science + Business Media, LLC. Manufactured in The Netherlands. DOI: 10.1007/s10851-006-9641-9 Fast Surface Segmentation Guided by User Input Using

Læs mere

User Manual for LTC IGNOU

User Manual for LTC IGNOU User Manual for LTC IGNOU 1 LTC (Leave Travel Concession) Navigation: Portal Launch HCM Application Self Service LTC Self Service 1. LTC Advance/Intimation Navigation: Launch HCM Application Self Service

Læs mere

Reexam questions in Statistics and Evidence-based medicine, august sem. Medis/Medicin, Modul 2.4.

Reexam questions in Statistics and Evidence-based medicine, august sem. Medis/Medicin, Modul 2.4. Reexam questions in Statistics and Evidence-based medicine, august 2013 2. sem. Medis/Medicin, Modul 2.4. Statistics : ESSAY-TYPE QUESTION 1. Intelligence tests are constructed such that the average score

Læs mere

Skriftlig Eksamen Beregnelighed (DM517)

Skriftlig Eksamen Beregnelighed (DM517) Skriftlig Eksamen Beregnelighed (DM517) Institut for Matematik & Datalogi Syddansk Universitet Mandag den 7 Januar 2008, kl. 9 13 Alle sædvanlige hjælpemidler (lærebøger, notater etc.) samt brug af lommeregner

Læs mere

Vores mange brugere på musskema.dk er rigtig gode til at komme med kvalificerede ønsker og behov.

Vores mange brugere på musskema.dk er rigtig gode til at komme med kvalificerede ønsker og behov. På dansk/in Danish: Aarhus d. 10. januar 2013/ the 10 th of January 2013 Kære alle Chefer i MUS-regi! Vores mange brugere på musskema.dk er rigtig gode til at komme med kvalificerede ønsker og behov. Og

Læs mere

SKRIFTLIG EKSAMEN I NUMERISK DYNAMIK Bygge- og Anlægskonstruktion, 7. semester Torsdag den 19. juni 2003 kl Alle hjælpemidler er tilladt

SKRIFTLIG EKSAMEN I NUMERISK DYNAMIK Bygge- og Anlægskonstruktion, 7. semester Torsdag den 19. juni 2003 kl Alle hjælpemidler er tilladt SKRIFTLIG EKSAMEN I NUMERISK DYNAMIK Bygge- og Anlægskonstruktion, 7. semester Torsdag den 9. juni 23 kl. 9.-3. Alle hjælpemidler er tilladt OPGAVE f(x) x Givet funktionen f(x) x, x [, ] Spørgsmål (%)

Læs mere

The X Factor. Målgruppe. Læringsmål. Introduktion til læreren klasse & ungdomsuddannelser Engelskundervisningen

The X Factor. Målgruppe. Læringsmål. Introduktion til læreren klasse & ungdomsuddannelser Engelskundervisningen The X Factor Målgruppe 7-10 klasse & ungdomsuddannelser Engelskundervisningen Læringsmål Eleven kan give sammenhængende fremstillinger på basis af indhentede informationer Eleven har viden om at søge og

Læs mere

Agenda. The need to embrace our complex health care system and learning to do so. Christian von Plessen Contributors to healthcare services in Denmark

Agenda. The need to embrace our complex health care system and learning to do so. Christian von Plessen Contributors to healthcare services in Denmark Agenda The need to embrace our complex health care system and learning to do so. Christian von Plessen Contributors to healthcare services in Denmark Colitis and Crohn s association Denmark. Charlotte

Læs mere

Statistik for MPH: 7

Statistik for MPH: 7 Statistik for MPH: 7 3. november 2011 www.biostat.ku.dk/~pka/mph11 Attributable risk, bestemmelse af stikprøvestørrelse (Silva: 333-365, 381-383) Per Kragh Andersen 1 Fra den 6. uges statistikundervisning:

Læs mere

X M Y. What is mediation? Mediation analysis an introduction. Definition

X M Y. What is mediation? Mediation analysis an introduction. Definition What is mediation? an introduction Ulla Hvidtfeldt Section of Social Medicine - Investigate underlying mechanisms of an association Opening the black box - Strengthen/support the main effect hypothesis

Læs mere

Angle Ini/al side Terminal side Vertex Standard posi/on Posi/ve angles Nega/ve angles. Quadrantal angle

Angle Ini/al side Terminal side Vertex Standard posi/on Posi/ve angles Nega/ve angles. Quadrantal angle Mrs. Valentine AFM Objective: I will be able to identify angle types, convert between degrees and radians for angle measures, identify coterminal angles, find the length of an intercepted arc, and find

Læs mere

Help / Hjælp

Help / Hjælp Home page Lisa & Petur www.lisapetur.dk Help / Hjælp Help / Hjælp General The purpose of our Homepage is to allow external access to pictures and videos taken/made by the Gunnarsson family. The Association

Læs mere

ESG reporting meeting investors needs

ESG reporting meeting investors needs ESG reporting meeting investors needs Carina Ohm Nordic Head of Climate Change and Sustainability Services, EY DIRF dagen, 24 September 2019 Investors have growing focus on ESG EY Investor Survey 2018

Læs mere

Den nye Eurocode EC Geotenikerdagen Morten S. Rasmussen

Den nye Eurocode EC Geotenikerdagen Morten S. Rasmussen Den nye Eurocode EC1997-1 Geotenikerdagen Morten S. Rasmussen UDFORDRINGER VED EC 1997-1 HVAD SKAL VI RUNDE - OPBYGNINGEN AF DE NYE EUROCODES - DE STØRSTE UDFORDRINGER - ER DER NOGET POSITIVT? 2 OPBYGNING

Læs mere

DET KONGELIGE BIBLIOTEK NATIONALBIBLIOTEK OG KØBENHAVNS UNIVERSITETS- BIBLIOTEK. Index

DET KONGELIGE BIBLIOTEK NATIONALBIBLIOTEK OG KØBENHAVNS UNIVERSITETS- BIBLIOTEK. Index DET KONGELIGE Index Download driver... 2 Find the Windows 7 version.... 2 Download the Windows Vista driver.... 4 Extract driver... 5 Windows Vista installation of a printer.... 7 Side 1 af 12 DET KONGELIGE

Læs mere

Trolling Master Bornholm 2014

Trolling Master Bornholm 2014 Trolling Master Bornholm 2014 (English version further down) Den ny havn i Tejn Havn Bornholms Regionskommune er gået i gang med at udvide Tejn Havn, og det er med til at gøre det muligt, at vi kan være

Læs mere

Molio specifications, development and challenges. ICIS DA 2019 Portland, Kim Streuli, Molio,

Molio specifications, development and challenges. ICIS DA 2019 Portland, Kim Streuli, Molio, Molio specifications, development and challenges ICIS DA 2019 Portland, Kim Streuli, Molio, 2019-06-04 Introduction The current structure is challenged by different factors. These are for example : Complex

Læs mere

Integrated Engine, Vehicle, and Underhood Model of a Light Duty Truck for VTM Analysis

Integrated Engine, Vehicle, and Underhood Model of a Light Duty Truck for VTM Analysis Integrated Engine, Vehicle, and Underhood Model of a Light Duty Truck for VTM Analysis GT-SUITE Conference 2009 Dr. Philip Keller Dr. Wolfgang Wenzel Dr. Michael Becker December 7, 2009 Outline Introduction

Læs mere

Constant Terminal Voltage. Industry Workshop 1 st November 2013

Constant Terminal Voltage. Industry Workshop 1 st November 2013 Constant Terminal Voltage Industry Workshop 1 st November 2013 Covering; Reactive Power & Voltage Requirements for Synchronous Generators and how the requirements are delivered Other countries - A different

Læs mere

Small Autonomous Devices in civil Engineering. Uses and requirements. By Peter H. Møller Rambøll

Small Autonomous Devices in civil Engineering. Uses and requirements. By Peter H. Møller Rambøll Small Autonomous Devices in civil Engineering Uses and requirements By Peter H. Møller Rambøll BACKGROUND My Background 20+ years within evaluation of condition and renovation of concrete structures Last

Læs mere

Userguide. NN Markedsdata. for. Microsoft Dynamics CRM 2011. v. 1.0

Userguide. NN Markedsdata. for. Microsoft Dynamics CRM 2011. v. 1.0 Userguide NN Markedsdata for Microsoft Dynamics CRM 2011 v. 1.0 NN Markedsdata www. Introduction Navne & Numre Web Services for Microsoft Dynamics CRM hereafter termed NN-DynCRM enable integration to Microsoft

Læs mere

RoE timestamp and presentation time in past

RoE timestamp and presentation time in past RoE timestamp and presentation time in past Jouni Korhonen Broadcom Ltd. 5/26/2016 9 June 2016 IEEE 1904 Access Networks Working Group, Hørsholm, Denmark 1 Background RoE 2:24:6 timestamp was recently

Læs mere

How Long Is an Hour? Family Note HOME LINK 8 2

How Long Is an Hour? Family Note HOME LINK 8 2 8 2 How Long Is an Hour? The concept of passing time is difficult for young children. Hours, minutes, and seconds are confusing; children usually do not have a good sense of how long each time interval

Læs mere

Special VFR. - ved flyvning til mindre flyveplads uden tårnkontrol som ligger indenfor en kontrolzone

Special VFR. - ved flyvning til mindre flyveplads uden tårnkontrol som ligger indenfor en kontrolzone Special VFR - ved flyvning til mindre flyveplads uden tårnkontrol som ligger indenfor en kontrolzone SERA.5005 Visual flight rules (a) Except when operating as a special VFR flight, VFR flights shall be

Læs mere

Basic Design Flow. Logic Design Logic synthesis Logic optimization Technology mapping Physical design. Floorplanning Placement Fabrication

Basic Design Flow. Logic Design Logic synthesis Logic optimization Technology mapping Physical design. Floorplanning Placement Fabrication Basic Design Flow System design System/Architectural Design Instruction set for processor Hardware/software partition Memory, cache Logic design Logic Design Logic synthesis Logic optimization Technology

Læs mere

DoodleBUGS (Hands-on)

DoodleBUGS (Hands-on) DoodleBUGS (Hands-on) Simple example: Program: bino_ave_sim_doodle.odc A simulation example Generate a sample from F=(r1+r2)/2 where r1~bin(0.5,200) and r2~bin(0.25,100) Note that E(F)=(100+25)/2=62.5

Læs mere

Gusset Plate Connections in Tension

Gusset Plate Connections in Tension Gusset Plate Connections in Tension Jakob Schmidt Olsen BSc Thesis Department of Civil Engineering 2014 DTU Civil Engineering June 2014 i Preface This project is a BSc project credited 20 ECTS points written

Læs mere

CS 4390/5387 SOFTWARE V&V LECTURE 5 BLACK-BOX TESTING - 2

CS 4390/5387 SOFTWARE V&V LECTURE 5 BLACK-BOX TESTING - 2 1 CS 4390/5387 SOFTWARE V&V LECTURE 5 BLACK-BOX TESTING - 2 Outline 2 HW Solution Exercise (Equivalence Class Testing) Exercise (Decision Table Testing) Pairwise Testing Exercise (Pairwise Testing) 1 Homework

Læs mere

Studieordning del 3,

Studieordning del 3, Studieordning del 3, 2014-2016 Autoteknolog, Valgfri Uddannelseselementer Academy Profession Degree in Automotive Technology Version 0.1 Revideret 19. august 2015 Side 0 af 6 Indhold Studieordningens del

Læs mere

MATHIC, SINGULAR & XMALLOC

MATHIC, SINGULAR & XMALLOC MATHIC, SINGULAR & XMALLOC Christian Eder POLSYS Team, UPMC, Paris, France June 11, 2013 1 / 17 1 SINGULAR Signature-based Gröbner Basis algorithms Restructuring SINGULAR 2 XMALLOC 3 MATHIC Overall structure

Læs mere

Statistical information form the Danish EPC database - use for the building stock model in Denmark

Statistical information form the Danish EPC database - use for the building stock model in Denmark Statistical information form the Danish EPC database - use for the building stock model in Denmark Kim B. Wittchen Danish Building Research Institute, SBi AALBORG UNIVERSITY Certification of buildings

Læs mere

Slot diffusers. Slot diffusers LD-17, LD-18

Slot diffusers. Slot diffusers LD-17, LD-18 LD-17, LD-18 Application LD-17 and LD-18 are designed for supply of cold or warm air in rooms with a height between. m and 4 m. They allow easy setting of air deflectors for different modes of operation

Læs mere

Shooting tethered med Canon EOS-D i Capture One Pro. Shooting tethered i Capture One Pro 6.4 & 7.0 på MAC OS-X 10.7.5 & 10.8

Shooting tethered med Canon EOS-D i Capture One Pro. Shooting tethered i Capture One Pro 6.4 & 7.0 på MAC OS-X 10.7.5 & 10.8 Shooting tethered med Canon EOS-D i Capture One Pro Shooting tethered i Capture One Pro 6.4 & 7.0 på MAC OS-X 10.7.5 & 10.8 For Canon EOS-D ejere der fotograferer Shooting tethered med EOS-Utility eller

Læs mere

Bilag 1 GPS dataudskrifter fra Stena Carisma ved passage af målefelt

Bilag 1 GPS dataudskrifter fra Stena Carisma ved passage af målefelt Bilag 1 GPS dataudskrifter fra Stena Carisma ved passage af målefelt Passage 1 Passage 2 Passage 3 Passage 4 Passage 5 27 Bilag 2 Engelsk beskrivelse af S4-måleren InterOcean S4 Current Meter The S4 Electromagnetic

Læs mere

Popular Sorting Algorithms CHAPTER 7: SORTING & SEARCHING. Popular Sorting Algorithms. Selection Sort 4/23/2013

Popular Sorting Algorithms CHAPTER 7: SORTING & SEARCHING. Popular Sorting Algorithms. Selection Sort 4/23/2013 Popular Sorting Algorithms CHAPTER 7: SORTING & SEARCHING Introduction to Computer Science Using Ruby Computers spend a tremendous amount of time sorting The sorting problem: given a list of elements in

Læs mere

Skidding System. Challenge Us

Skidding System. Challenge Us Skidding System n Malm Orstads cutting edge Engineering department designs and fabricates tailor made skidding systems for all kinds of enviroments. Our skidding systems are amongst the most efficient

Læs mere

Self-Organization in Autonomous Sensor/Actuator Networks [SelfOrg]

Self-Organization in Autonomous Sensor/Actuator Networks [SelfOrg] Self-Organization in Autonomous Sensor/Actuator Networks [SelfOrg] Dr.-Ing. Falko Dressler Computer Networks and Communication Systems Department of Computer Sciences University of Erlangen-Nürnberg http://www7.informatik.uni-erlangen.de/~dressler/

Læs mere

Statistik for MPH: oktober Attributable risk, bestemmelse af stikprøvestørrelse (Silva: , )

Statistik for MPH: oktober Attributable risk, bestemmelse af stikprøvestørrelse (Silva: , ) Statistik for MPH: 7 29. oktober 2015 www.biostat.ku.dk/~pka/mph15 Attributable risk, bestemmelse af stikprøvestørrelse (Silva: 333-365, 381-383) Per Kragh Andersen 1 Fra den 6. uges statistikundervisning:

Læs mere

how to save excel as pdf

how to save excel as pdf 1 how to save excel as pdf This guide will show you how to save your Excel workbook as PDF files. Before you do so, you may want to copy several sheets from several documents into one document. To do so,

Læs mere

Strings and Sets: set complement, union, intersection, etc. set concatenation AB, power of set A n, A, A +

Strings and Sets: set complement, union, intersection, etc. set concatenation AB, power of set A n, A, A + Strings and Sets: A string over Σ is any nite-length sequence of elements of Σ The set of all strings over alphabet Σ is denoted as Σ Operators over set: set complement, union, intersection, etc. set concatenation

Læs mere

Bookingmuligheder for professionelle brugere i Dansehallerne 2015-16

Bookingmuligheder for professionelle brugere i Dansehallerne 2015-16 Bookingmuligheder for professionelle brugere i Dansehallerne 2015-16 Modtager man økonomisk støtte til et danseprojekt, har en premieredato og er professionel bruger af Dansehallerne har man mulighed for

Læs mere

United Nations Secretariat Procurement Division

United Nations Secretariat Procurement Division United Nations Secretariat Procurement Division Vendor Registration Overview Higher Standards, Better Solutions The United Nations Global Marketplace (UNGM) Why Register? On-line registration Free of charge

Læs mere

Sunlite pakke 2004 Standard (EC) (SUN SL512EC)

Sunlite pakke 2004 Standard (EC) (SUN SL512EC) Sunlite pakke 2004 Standard (EC) (SUN SL512EC) - Gruppering af chasere igen bag efter. På den måde kan laves cirkelbevægelser og det kan 2,787.00 DKK Side 1 Sunlite pakke 2006 Standard (EC) LAN (SUN SL512EC

Læs mere

FACULTY OF SCIENCE :59 COURSE. BB838: Basic bioacoustics using Matlab

FACULTY OF SCIENCE :59 COURSE. BB838: Basic bioacoustics using Matlab FACULTY OF SCIENCE 01-12- 11:59 COURSE BB838: Basic bioacoustics using Matlab 28.03. Table Of Content Internal Course Code Course title ECTS value STADS ID (UVA) Level Offered in Duration Teacher responsible

Læs mere

Application of High- resolution LiDAR-derived DEM in Landslide Volume Estimation

Application of High- resolution LiDAR-derived DEM in Landslide Volume Estimation Application of High- resolution LiDAR-derived DEM in Landslide Volume Estimation Chih Ming Tseng 1, Ching Weei Lin 2, Jin King Liu 1. Chang Jung Christian University 2. National Cheng Kung University TAIWAN

Læs mere

Evaluating Germplasm for Resistance to Reniform Nematode. D. B. Weaver and K. S. Lawrence Auburn University

Evaluating Germplasm for Resistance to Reniform Nematode. D. B. Weaver and K. S. Lawrence Auburn University Evaluating Germplasm for Resistance to Reniform Nematode D. B. Weaver and K. S. Lawrence Auburn University Major objectives Evaluate all available accessions of G. hirsutum (TX list) for reaction to reniform

Læs mere

University of Copenhagen Faculty of Science Written Exam April Algebra 3

University of Copenhagen Faculty of Science Written Exam April Algebra 3 University of Copenhagen Faculty of Science Written Exam - 16. April 2010 Algebra This exam contains 5 exercises which are to be solved in hours. The exercises are posed in an English and in a Danish version.

Læs mere

Avancerede bjælkeelementer med tværsnitsdeformation

Avancerede bjælkeelementer med tværsnitsdeformation Avancerede bjælkeelementer med tværsnitsdeformation Advanced beam element with distorting cross sections Kandidatprojekt Michael Teilmann Nielsen, s062508 Foråret 2012 Under vejledning af Jeppe Jönsson,

Læs mere

University of Copenhagen Faculty of Science Written Exam - 3. April Algebra 3

University of Copenhagen Faculty of Science Written Exam - 3. April Algebra 3 University of Copenhagen Faculty of Science Written Exam - 3. April 2009 Algebra 3 This exam contains 5 exercises which are to be solved in 3 hours. The exercises are posed in an English and in a Danish

Læs mere

Some results for the weighted Drazin inverse of a modified matrix

Some results for the weighted Drazin inverse of a modified matrix International Journal of Applied Mathematics Computation Journal homepage: www.darbose.in/ijamc ISSN: 0974-4665 (Print) 0974-4673 (Online) Volume 6(1) 2014 1 9 Some results for the weighted Drazin inverse

Læs mere

UNISONIC TECHNOLOGIES CO.,

UNISONIC TECHNOLOGIES CO., UNISONIC TECHNOLOGIES CO., 3 TERMINAL 1A NEGATIVE VOLTAGE REGULATOR DESCRIPTION 1 TO-263 The UTC series of three-terminal negative regulators are available in TO-263 package and with several fixed output

Læs mere

what is this all about? Introduction three-phase diode bridge rectifier input voltages input voltages, waveforms normalization of voltages voltages?

what is this all about? Introduction three-phase diode bridge rectifier input voltages input voltages, waveforms normalization of voltages voltages? what is this all about? v A Introduction three-phase diode bridge rectifier D1 D D D4 D5 D6 i OUT + v OUT v B i 1 i i + + + v 1 v v input voltages input voltages, waveforms v 1 = V m cos ω 0 t v = V m

Læs mere

Appendix 1: Interview guide Maria og Kristian Lundgaard-Karlshøj, Ausumgaard

Appendix 1: Interview guide Maria og Kristian Lundgaard-Karlshøj, Ausumgaard Appendix 1: Interview guide Maria og Kristian Lundgaard-Karlshøj, Ausumgaard Fortæl om Ausumgaard s historie Der er hele tiden snak om værdier, men hvad er det for nogle værdier? uddyb forklar definer

Læs mere

Info og krav til grupper med motorkøjetøjer

Info og krav til grupper med motorkøjetøjer Info og krav til grupper med motorkøjetøjer (English version, see page 4) GENERELT - FOR ALLE TYPER KØRETØJER ØJER GODT MILJØ FOR ALLE Vi ønsker at paraden er en god oplevelse for alle deltagere og tilskuere,

Læs mere

Freefly B-Række Regler

Freefly B-Række Regler Freefly B-Række Regler Freefly B-Rækken er skabt til at imødekomme både nye og erfarende freeflyere, og præsentere dem for konkurrence elementet. Der konkurreres efter FAI regler, men der forekommer dog

Læs mere

Pontryagin Approximations for Optimal Design of Elastic Structures

Pontryagin Approximations for Optimal Design of Elastic Structures Pontryagin Approximations for Optimal Design of Elastic Structures Jesper Carlsson NADA, KTH jesperc@nada.kth.se Collaborators: Anders Szepessy, Mattias Sandberg October 5, 2005 A typical optimal design

Læs mere

Probabilistic properties of modular addition. Victoria Vysotskaya

Probabilistic properties of modular addition. Victoria Vysotskaya Probabilistic properties of modular addition Victoria Vysotskaya JSC InfoTeCS, NPK Kryptonite CTCrypt 19 / June 4, 2019 vysotskaya.victory@gmail.com Victoria Vysotskaya (Infotecs, Kryptonite) Probabilistic

Læs mere

Web-seminar. 30 March Noter

Web-seminar. 30 March Noter Web-seminar 30 March 2017 Noter Følg mig på www.tomhougaard.dk Hvad er Day Trading og Spekulation? Attachment is the great fabricator of illusions; reality can be attained only by someone who is detached.

Læs mere