File:Ecart cercle ideal cercle reel mmt.svg

Original file(SVG file, nominally 572 × 862 pixels, file size: 180 KB)

Captions

Captions

Add a one-line explanation of what this file represents

Summary edit

Description
Français : Comparaison entre un cercle parfait et une arête circulaire d'une pièce réelle. Le profil réel peut être obtenu avec une machine à mesurer tridimensionnelle, ou bien représenter la déformation sous charge calculée par éléments finis.
  • Haut : le défaut axial est amplifié d'un facteur 100 ;
  • bas : le défaut radial est amplifié d'un facteur 100 ;
    le plan moyen est déterminé par régression linéaire multiple, les points sont projettés sur ce plan, et le centre du cercle modèle est déterminé par régression circulaire.
Le système est un épaulement circulaire réalisé sur une structure mécano-soudée, et destiné à servir de mise en position (MiP).
English: Comparison between a perfect circle and the circular edge of a real part. The real profile can be retrieved by coordinate metrology, or can represent the deformation under load as calculated by finite elements analysis.
  • Top: the axial defect is amplified by 100;
  • bottom: the radial defect is amplified by 100;
    the average plane is determined by multiple linear regression, the points are projected on this plane, then the center of the model circle is determined by circle fitting.
The system is a flange made on a welded structure, used for the positioning.
Date
Source Own work, made with Scilab, modified with Inkscape
Author Cdang
 
W3C-validity not checked.

Scilab source

General functions, in the fonctions_cercle_mmt.sci file.

function [W] = produit_vectoriel(U, V)
    // But : calcule W = U^V
    // Entrées : U, V, vecteurs ligne
    // Sortie : W, vecteur ligne
    W(1, 1) = U(2)*V(3) - U(3)*V(2);
    W(1, 2) = U(3)*V(1) - U(1)*V(3);
    W(1, 3) = U(1)*V(2) - U(2)*V(1);
endfunction

function [Xp, Yp, B, N, ux, uy] = regression_plan(X, Y, Z)
    // But : se placer dans le plan moyen
    // Moyen : à partir des données expérimentales X, Y et Z
    // déterminer l'équation du plan y = A(1)x + A(2)z + b
    // (soit A(1)x - y + A(2)z + b = 0)
    // par régression multilinéaire
    // puis projetter sur les projections des axes x et y sur le plan
    // Entrées : X, Y, Z : vecteurs colonne de réels
    // Sorties : Xp, Yp : vecteurs colonne de réels
    // N : vecteur normal, vecteur ligne de réels
    // ux, uy, BON du plan, vecteurs ligne
    
    // Régression plane
    // y = A(1)*x + A(2)*z + b
    [A, b, sigma] = reglin([X' ; Z'], Y');
    disp("Équation du plan moyen : ");
    disp("y = ("+string(A(1))+")*x + ("+string(A(2))+")*z + ("+string(b)+")");
    
    // Intersection du plan avec l'axe y
    B = [0, b, 0];
    
    // vecteur normal unitaire
    N = [A(1), -1, A(2)]/norm([A(1), -1, A(2)]);
    
    // vecteur unitaire de l'intersection du plan avec la plan (x, y)
    // soit le plan z = 0
    // droite d'équation A(1)x - y + b = 0, z = 0
    ux = [1, A(1), 0]/norm([1, A(1) 0]);
    
    // deuxième vecteur de la base du plan (produit vectoriel)
    uuy = produit_vectoriel(N, ux);
    uy = uuy/norm(uuy);
    // projection
    Xp = [X, Y, Z]*ux';
    Yp = [X, Y, Z]*uy';    
endfunction

function [xc, yc, r] = rc_kasa_coope(X, Y)
    // calcule les paramètres du cercle décrivant le mieux les points
    // selon la méthode linéaire de I. Kasa et Ian D. Coope
    // Entrée : X, Y, vecteurs colonne de réels
    // Sortie : xc, yc, réels, coordonnées du centre dans le plan
    // r : rayon du cercle
    
    // d = A(1)x + A(2)y + b avec d = x^2 + y^2
    d = X.^2 + Y.^2;
    [A, b, sigma] = reglin([X' ; Y'], d');
    
    // équation cartésienne sous la forme
    // (x^2 + y^2) - (r^2 - xc^2 - yc^2) - (2xc)x - (2yc)y
    xc = A(1)/2; yc = A(2)/2;
    r = sqrt(b + xc^2 + yc^2);
endfunction

function [S] = residus(A, X, Y)
    // But : calculer les mondres carrés totaux
    // si = sqrt((xi - xc)^2 + (yi - yc)^2)
    // S = 1/n*somme si
    // Entrées : A, paramètres de la loi, vecteur ligne de réels
    // A(1) = xc, A(2) = yc, A(3) = r
    // X, Y, vecteurs colonne de réels
    // Sortie : S, réel
    n = size(X, '*');
    s = (((X - A(1)).^2 + (Y - A(2)).^2).^0.5 - A(3)).^2;
    S = sqrt(sum(s)/n);
endfunction

function [xc, yc, r] = regression_circulaire(X, Y)
    // calcule les paramètres du cercle décrivant le mieux les points
    // Entrée : X, Y, vecteurs colonne de réels
    // Sortie : xc, yc, réels, coordonnées du centre dans le plan
    // r : rayon du cercle
    
    // première estimation par la méthode linéaire de Kasa et Coope
    [xc0, yc0, r0] = rc_kasa_coope(X, Y);
    //disp("Régression circulaire, Kasa et Coope : ")
    //disp("C ("+string(xc0)+" ; "+string(yc0)+") ; r = "+string(r0));
    
    // régression par les moindres carrés totaux
    Ainit = [xc0, yc0, r0];
    [sigma, Aopt] = leastsq(list(residus, X, Y), Ainit);
    xc = Aopt(1) ; yc = Aopt(2) ;
    r = Aopt(3);
    disp("Régression circulaire, moindrees carrés totaux : ")
    disp("C ("+string(xc0)+" ; "+string(yc0)+") ; r = "+string(r0));
endfunction

Creation of data: creation of the cercle_deforme.csv file.

chemin_fcts = "mypath/";

chdir(chemin_fcts);

n = 24; // nombre de points
pas = 2*%pi/n;

xc = 0; yc = 0; zc = 0; // centre du cercle
R = 1; // rayon du cercle

dx = 5e-2; dy = 1e-4; dz = 2e-2; // décalage du centre

N = 3; // ordre de symétrie de la déformation
dR = 1e-3; // demie amplitude de la déformation radiale
dY = 5e-4; // " axiale 

dThetaX = 2e-3*%pi/180; // inclinaison selon l'axe x
dThetaZ = 1e-3*%pi/180; // inclinaison selon l'axe z
etR = 8e-4; // écart type sur R
etY = 1e-4; // écart type sur Z

phi = linspace(0, 2*%pi-pas, n)';

rayon = R*(1 + dR*cos(N*phi) + etR*rand(n, 1)); //
X = rayon.*cos(phi)*cos(dThetaZ) + dx;
Y = (etY*rand(n, 1) + dY*cos(N*phi))*cos(dThetaX)*cos(dThetaZ) + dy
Z = rayon.*sin(phi)*cos(dThetaX) + dz;

matrice = [X, Y, Z];

csvWrite(matrice, "cercle_deforme.csv")

Main script.

// **********
// Constantes
// **********

echelle = 100; // amplification de l'écart au cercle
chemin_fcts = "mypath/";

// **********
// Données
// **********

// cercle idéal

xc0 = 0; yc0 = 0; zc0 = 0;
r0 = 1;

// cercle déformé

chdir(chemin_fcts);
matrice = csvRead("cercle_deforme.csv")
X1 = matrice(:, 1);
Y1 = matrice(:, 2);
Z1 = matrice(:, 3);

// **********
// Fonctions
// **********

exec("fonctions_cercle_mmt.sci"); // chargement des fonctions

function [Xp, Yp, xc, yc, r, B, N, ux, uy] = cercle_projete(X, Y, Z)
    // But : détermine le plan moyen,
    // projette les points expérimentaux
    // et détermine les caractéristique du meilleur cercle
    // Entrées : X, Y, Z, vecteurs colonne de réels
    // Sorties : Xp, Yp, vecteurs colonne de réels
    // coordonnées des points projetés
    // xc, yc, r, réels
    // paramètres du cercle
    
    // Projection sur le plan moyen
    [Xp, Yp, B, N, ux, uy] = regression_plan(X, Y, Z);
    // Régression circulaire
    [xc, yc, r] = regression_circulaire(Xp, Yp);
endfunction

function [] = trace_cercle_projete(xc, yc, zc, r, B, N, ux, uy, ech)
    // But : tracer le cercle de référence
    // et sa projection sur le plan moyen
    // Entréées : xc, yc, zc, r, paramètres du cercle, réels
    // B : intersection du plan moyen avec l'axe y, réel
    // N : vecteur normal au plan moyen, vecteur ligne de réels
    // ux, uy : BON du plan moyen, vecteurs ligne de réels
    // ceh : facteur d'échelle, réel
    
    // cercle de base
    theta1 = linspace(0, 0.45*%pi, 9);
    theta = [theta1, theta1+%pi/2, theta1+%pi, theta1+3*%pi/2, 2*%pi];
    X0 = xc + r*cos(theta); Y0 = yc*ones(1, 37); Z0 = zc + r*sin(theta);
    param3d(X0, Y0, Z0);
    h1 = gce();
    h1.line_style = 3;
    param3d(xc, yc, zc);
    h2 = gce();
    h2.mark_style = 1;
    
    // cercle projeté
    BA = [X0 - B(1) ; Y0 - B(2) ; Z0 - B(3)] // vecteur BA, A pt exp
    B2prime = yc + ech*(B(2) - yc);
    Ux = ux*BA ; Uy = uy*BA; // projections sur le plan, vect ligne
    X1 = B(1) + ux(1)*Ux + uy(1)*Uy;
    Y1 = B2prime + ech*(ux(2)*Ux + uy(2)*Uy);
    Z1 = B(3) + ux(3)*Ux + uy(3)*Uy;
    param3d(X1, Y1, Z1)
    h3 = gce();
    h3.foreground = 2;
    h3.line_style = 4;
    param3d(xc, B2prime, zc)
    h4 = gce();
    h4.mark_foreground = 2;
    h4.mark_style = 1;
endfunction

function [] = trace_cercle_ax(X, Y, Z, xc, yc, zc, r, ech)
    // But : trace les points expérimentaux en amplifiant l'écart radial
    // d'un facteur ech
    // Entrées : X, Y, Z, vecteurs colonne de réels, points relevés
    // xc, yc, zc, r, réels, paramètres du cercle idéal
    // ech, réel, facteur d'échelle
    
    // points relevés
    ymoy = mean(Y); // altitude moyenne
    Yamplifie = yc + ech*(Y - yc);
    param3d([X ; X(1)], [Yamplifie ; Yamplifie(1)], [Z ; Z(1)], 90, 5);
    h2 = gce();
    h2.foreground = 2;
    h2.mark_style=1;
    h2.mark_foreground=2;
    // titre
    xtitle("Écart axial ×"+string(ech));
endfunction

function [] = trace_cercle_rad(X, Y, xc, yc, r, ech)
    // trace le cercle idéal projeté
    // et les points expérimentaux projetés en amplifiant l'écart radial
    // d'un facteur ech
    // Entrées : X, Y, vecteurs colonne de réels, points relevés projetés
    // xc, yc, r, réels, paramètres du cercle idéal projeté
    // ech, réel, facteur d'échelle
    
    // cercle idéal
    diam = 2*r;
    xarc(xc - r, yc + r, diam, diam, 0, 360*64)
    h1 = gce();
    h1.line_style = 3;
    
    // cercle réel
    R = ((X-xc).^2 + (Y-yc).^2).^0.5; // distance de chaque point au centre
    angle = atan(Y-yc, X-xc);
    R1 = ech*(R-r) + r; // distance avec écart amplifié
    XX = R1.*cos(angle) + xc;
    YY = R1.*sin(angle) + yc;
    plot(XX, YY, "+") // tracé des points
    plot([XX ; XX(1)], [YY ; YY(1)], "-") // relie les points
    a = get("current_axes");
    a.isoview = "on";
    xtitle("Écart radial ×"+string(ech), "x", "y");
endfunction

// **********
// Programme principal
// **********

// écart axial, précision micromètre
ecart_axial = Y1-yc0;
eamax = round(1000*max(ecart_axial))/1000;
eamin = round(1000*min(ecart_axial))/1000;

// Déformée

// Projection sur le plan moyen
// et détermination du centre du cercle idéal
[Xproj1, Yproj1, xc1, yc1, r1, B, N, ux, uy] = cercle_projete(X1, Y1, Z1)

// Angle par rapport au vecteur y, arrondi au 1/1000
alpha = 0.001*round(acos(N*[0;-1;0])*180000/%pi);
disp("Défaut d''orientation : "+string(alpha));

// tracé en perspective des points par rapport à leur position d'origine
// écart axial (altitude) amplifié
f0 = scf(0); clf;
//subplot(1, 2, 1);
trace_cercle_projete(xc0, yc0, zc0, r0, B, N, ux, uy, echelle)
trace_cercle_ax(X1, Y1, Z1, xc0, yc0, zc0, r0, echelle);

// Tracé du cercle idéal et des points déplacés
f1 = scf(1); clf;
//subplot(1, 2, 2);
trace_cercle_rad(Xproj1, Yproj1, xc1, yc1, r0, echelle);

// écart radial, précision micromètre
disp("Déformée");
ecart_radial = ((Xproj1 - xc1).^2 + (Yproj1 - yc1).^2).^0.5 - r0;
ermax = round(1000*max(ecart_radial))/1000;
ermin = round(1000*min(ecart_radial))/1000;

// tracé de l'écart en fonction de l'angle

// Affichage résultats
disp("Écart axial : "+string(eamin)+" ≤ ea ≤ "+string(eamax));
disp("Écart radial : "+string(ermin)+" ≤ er ≤ "+string(ermax));
Points
1.0513160932628853,0.00064532337412618896,0.02
1.0170294270986409,0.00047618195963036432,0.27911475392981583
0.91612453119408044,0.00011486739398710693,0.5200572310081516
0.75701212113883687,-0.00022920336632785985,0.72701212081578459
0.54983075893601163,-0.00036155452371815808,0.88573226926730841
0.30865267584045264,-0.00024214060187082511,0.98530492730913932
0.049999999999999843,0.00013649685766562526,1.0206107799196984
-0.20914225956526139,0.00054734818370194116,0.98713207864384933
-0.45053203458482688,0.00062138825694439952,0.88694691432061123
-0.65792535346434211,0.00054163093477104256,0.7279253531408727
-0.81660738267553357,0.00013025345795346599,0.52033600544081959
-0.91594932905935622,-0.0002241951132490402,0.27882534253257557
-0.94976528882840472,-0.0003093210382529513,0.019999999999999678
-0.91537236949333023,-0.00017395878357159866,-0.23867074668286428
-0.81632650122577344,0.00010202379724788095,-0.48017383846026462
-0.65763039937083079,0.00047077393233200914,-0.68763039904749623
-0.45069330982111017,0.00062199750991832664,-0.84722625122373052
-0.20906188249344704,0.00052904330365935058,-0.94683210732821221
0.049999999999999822,0.00014089378818549347,-0.98032926172430046
0.3086815901059124,-0.00020674542770365205,-0.94541283681685129
0.54962578674935847,-0.00035791187302727708,-0.84537724702604822
0.7567614339572285,-0.00017874937017361861,-0.68676143363428965
0.91655831063494664,0.00012455636871039767,-0.48030767368499072
1.0166512254357472,0.00045613127910140716,-0.23901341509971349

Licensing edit

I, the copyright holder of this work, hereby publish it under the following license:
w:en:Creative Commons
attribution share alike
This file is licensed under the Creative Commons Attribution-Share Alike 3.0 Unported license.
You are free:
  • to share – to copy, distribute and transmit the work
  • to remix – to adapt the work
Under the following conditions:
  • attribution – You must give appropriate credit, provide a link to the license, and indicate if changes were made. You may do so in any reasonable manner, but not in any way that suggests the licensor endorses you or your use.
  • share alike – If you remix, transform, or build upon the material, you must distribute your contributions under the same or compatible license as the original.

File history

Click on a date/time to view the file as it appeared at that time.

Date/TimeThumbnailDimensionsUserComment
current11:27, 5 June 2019Thumbnail for version as of 11:27, 5 June 2019572 × 862 (180 KB)Cdang (talk | contribs)additional lines + valid SVG
07:58, 1 June 2019Thumbnail for version as of 07:58, 1 June 2019572 × 862 (161 KB)Cdang (talk | contribs)different set of data
10:51, 25 January 2013Thumbnail for version as of 10:51, 25 January 2013503 × 816 (164 KB)Cdang (talk | contribs)* Top: offset according to the scale. * Bottom: dashed ellipse.
12:46, 24 January 2013Thumbnail for version as of 12:46, 24 January 2013503 × 816 (158 KB)Cdang (talk | contribs)User created page with UploadWizard

There are no pages that use this file.

File usage on other wikis

The following other wikis use this file:

Metadata