玩软件 > CAD技巧
+

《CAD/CAM技术及应用》试题(3)

2016-09-25    作者:未知    来源:网络文摘

六、某线图的五个点如下左图所示,各点坐标如右表所示。

(1)如采用/格朗日插值原理进行插值,试绘出实现插值计算的计算机程序流程图。(10分)

(2)采用某种计算机编程语言(如C、Basic),编写程序实现该线图的拉格朗日插值计算。(10分)

《CAD/CAM技术及应用》试题

           


《CAD/CAM技术及应用》试题

算出每个欧拉公式的基本项《CAD/CAM技术及应用》试题《CAD/CAM技术及应用》试题《CAD/CAM技术及应用》试题《CAD/CAM技术及应用》试题《CAD/CAM技术及应用》试题

《CAD/CAM技术及应用》试题

(2)编程:

xOffset = 1;

if (nargin==2) || ...

        (nargin==3 && ischar(varargin{3}))  || ...

        (nargin==4 && (~ischar(varargin{4}) || strcmp(varargin{4}, 'extrap')));

    xOffset = 0;

end

ppOutput = false;

% PP = INTERP1(X,Y,METHOD,'pp')

if nargin>=4 && ischar(varargin{3}) && isequal('pp',varargin{4})

    ppOutput = true;

    if (nargin > 4)

        error('MATLAB:interp1:ppOutput', ...

            'Use 4 inputs for PP=INTERP1(X,Y,METHOD,''pp'').')

    end

end

% Process Y in INTERP1(Y,...) and INTERP1(X,Y,...)

y = varargin{1+xOffset};

siz_y = size(y);

% y may be an ND array, but collapse it down to a 2D yMat. If yMat is

% a vector, it is a column vector.

if isvector(y)

    if size(y,1) == 1

        % Prefer column vectors for y

        yMat = y.';

        n = siz_y(2);

    else

        yMat = y;

        n = siz_y(1);

    end

    ds = 1;

    prodDs = 1;

else

    n = siz_y(1);

    ds = siz_y(2:end);

    prodDs = prod(ds);

    yMat = reshape(y,[n prodDs]);

end

% Process X in INTERP1(X,Y,...), or supply default for INTERP1(Y,...)

if xOffset

    x = varargin{xOffset};

    if ~isvector(x)

        error('MATLAB:interp1:Xvector','X must be a vector.');

    end

    if length(x) ~= n

        if isvector(y)

            error('MATLAB:interp1:YInvalidNumRows', ...

                'X and Y must be of the same length.')

        else

            error('MATLAB:interp1:YInvalidNumRows', ...

                'LENGTH(X) and SIZE(Y,1) must be the same.');

        end

    end

    % Prefer column vectors for x

    xCol = x(:);

else

    xCol = (1:n)';

end

% Process XI in INTERP1(Y,XI,...) and INTERP1(X,Y,XI,...)

% Avoid syntax PP = INTERP1(X,Y,METHOD,'pp')

if ~ppOutput

    xi = varargin{2+xOffset};

    siz_xi = size(xi);

    % xi may be an ND array, but flatten it to a column vector xiCol

    xiCol = xi(:);

    % The size of the output YI

    if isvector(y)

        % Y is a vector so size(YI) == size(XI)

        siz_yi = siz_xi;

    else

        if isvector(xi)

            % Y is not a vector but XI is

            siz_yi = [length(xi) ds];

        else

            % Both Y and XI are non-vectors

            siz_yi = [siz_xi ds];

        end

    end

end

if xOffset && ~isreal(x)

    error('MATLAB:interp1:ComplexX','X should be a real vector.')

end

if ~ppOutput && ~isreal(xi)

    error('MATLAB:interp1:ComplexInterpPts', ...

        'The interpolation points XI should be real.')

end

% Error check for NaN values in X and Y

% check for NaN's

if xOffset && (any(isnan(xCol)))

    error('MATLAB:interp1:NaNinX','NaN is not an appropriate value for X.');

end

% NANS are allowed as a value for F(X), since a function may be undefined

% for a given value.

if any(isnan(yMat(:)))

    warning('MATLAB:interp1:NaNinY', ...

        ['NaN found in Y, interpolation at undefined values \n\t',...

        ' will result in undefined values.']);

end

if (n < 2)

    if ppOutput || ~isempty(xi)

        error('MATLAB:interp1:NotEnoughPts', ...

            'There should be at least two data points.')

    else

        yi = zeros(siz_yi,superiorfloat(x,y,xi));

        varargout{1} = yi;

        return

    end

end

% Process METHOD in

% PP = INTERP1(X,Y,METHOD,'pp')

% YI = INTERP1(Y,XI,METHOD,...)

% YI = INTERP1(X,Y,XI,METHOD,...)

% including explicit specification of the default by an empty input.

if ppOutput

    if isempty(varargin{3})

        method = 'linear';

    else

        method = varargin{3};

    end

else

    if nargin >= 3+xOffset && ~isempty(varargin{3+xOffset})

        method = varargin{3+xOffset};

    else

        method = 'linear';

    end

end

   

% The v5 option, '*method', asserts that x is equally spaced.

eqsp = (method(1) == '*');

if eqsp

    method(1) = [];

end

% INTERP1([X,]Y,XI,METHOD,'extrap') and INTERP1([X,]Y,Xi,METHOD,EXTRAPVAL)

if ~ppOutput

    if nargin >= 4+xOffset

        extrapval = varargin{4+xOffset};

    else

        switch method(1)

            case {'s','p','c'}

                extrapval = 'extrap';

            otherwise

                extrapval = NaN;

        end

    end

end

% Start the algorithm

% We now have column vector xCol, column vector or 2D matrix yMat and

% column vector xiCol.

if xOffset

    if ~eqsp

        h = diff(xCol);

        eqsp = (norm(diff(h),Inf) <= eps(norm(xCol,Inf)));

        if any(~isfinite(xCol))

            eqsp = 0; % if an INF in x, x is not equally spaced

        end

    end

    if eqsp

        h = (xCol(n)-xCol(1))/(n-1);

    end

else

    h = 1;

    eqsp = 1;

end

if any(h < 0)

    [xCol,p] = sort(xCol);

    yMat = yMat(p,:);

    if eqsp

        h = -h;

    else

        h = diff(xCol);

    end

end

if any(h == 0)

    error('MATLAB:interp1:RepeatedValuesX', ...

        'The values of X should be distinct.');

end

% PP = INTERP1(X,Y,METHOD,'pp')

if nargin==4 && ischar(varargin{3}) && isequal('pp',varargin{4})

    % obtain pp form of output

    pp = ppinterp;

    varargout{1} = pp;

    return

end

% Interpolate

numelXi = length(xiCol);

p = [];

switch method(1)

    case 's'  % 'spline'

        % spline is oriented opposite to interp1

        yiMat = spline(xCol.',yMat.',xiCol.').';

    case {'c','p'}  % 'cubic' or 'pchip'

        % pchip is oriented opposite to interp1

        yiMat = pchip(xCol.',yMat.',xiCol.').';

    otherwise % 'nearest', 'linear', 'v5cubic'

        yiMat = zeros(numelXi,prodDs,superiorfloat(xCol,yMat,xiCol));

        if ~eqsp && any(diff(xiCol) < 0)

            [xiCol,p] = sort(xiCol);

        else

            p = 1:numelXi;

        end

        % Find indices of subintervals, x(k) <= u < x(k+1),

        % or u < x(1) or u >= x(m-1).

        if isempty(xiCol)

            k = xiCol;

        elseif eqsp

            k = min(max(1+floor((xiCol-xCol(1))/h),1),n-1);

        else

            [ignore,k] = histc(xiCol,xCol);

            k(xiCol

            k(xiCol>=xCol(n)) = n-1;

        end

        switch method(1)

            case 'n'  % 'nearest'

                i = find(xiCol >= (xCol(k)+xCol(k+1))/2);

                k(i) = k(i)+1;

                yiMat(p,:) = yMat(k,:);

            case 'l'  % 'linear'

                if eqsp

                    s = (xiCol - xCol(k))/h;

                else

                    s = (xiCol - xCol(k))./h(k);

                end

                for j = 1:prodDs

                    yiMat(p,j) = yMat(k,j) + s.*(yMat(k+1,j)-yMat(k,j));

                end

            case 'v'  % 'v5cubic'

                extrapval = NaN;

                if eqsp

                    % Data are equally spaced

                    s = (xiCol - xCol(k))/h;

                    s2 = s.*s;

                    s3 = s.*s2;

                    % Add extra points for first and last interval

                    yMat = [3*yMat(1,:)-3*yMat(2,:)+yMat(3,:); ...

                        yMat; ...

                        3*yMat(n,:)-3*yMat(n-1,:)+yMat(n-2,:)];

                    for j = 1:prodDs

                        yiMat(p,j) = (yMat(k,j).*(-s3+2*s2-s) + ...

                            yMat(k+1,j).*(3*s3-5*s2+2) + ...

                            yMat(k+2,j).*(-3*s3+4*s2+s) + ...

                            yMat(k+3,j).*(s3-s2))/2;

                    end

                else

                    % Data are not equally spaced

                    % spline is oriented opposite to interp1

                    yiMat = spline(xCol.',yMat.',xiCol.').';

                end

            otherwise

                error('MATLAB:interp1:InvalidMethod','Invalid method.')

        end

end

% Override extrapolation

if ~isequal(extrapval,'extrap')

    if ischar(extrapval)

        error('MATLAB:interp1:InvalidExtrap', 'Invalid extrap option.')

    elseif ~isscalar(extrapval)

        error('MATLAB:interp1:NonScalarExtrapValue',...

            'EXTRAP option must be a scalar.')

    end

    if isempty(p)

        p = 1 : numelXi;

    end

     outOfBounds = xiColxCol(n);

     yiMat(p(outOfBounds),:) = extrapval;

end

% Reshape result, possibly to an ND array

yi = reshape(yiMat,siz_yi);

varargout{1} = yi;

%-------------------------------------------------------------------------%

    function pp = ppinterp

        %PPINTERP ppform interpretation.

        switch method(1)

            case 'n' % nearest

                breaks = [xCol(1); ...

                    (xCol(1:end-1)+xCol(2:end))/2; ...

                    xCol(end)].';

                coefs = yMat.';

                pp = mkpp(breaks,coefs,ds);

            case 'l' % linear

                breaks = xCol.';

                page1 = (diff(yMat)./repmat(diff(xCol),[1, prodDs])).';

                page2 = (reshape(yMat(1:end-1,:),[n-1, prodDs])).';

                coefs = cat(3,page1,page2);

                pp = mkpp(breaks,coefs,ds);

            case {'p', 'c'} % pchip and cubic

                pp = pchip(xCol.',reshape(yMat.',[ds, n]));

            case 's' % spline

                pp = spline(xCol.',reshape(yMat.',[ds, n]));

            case 'v' % v5cubic

                b = diff(xCol);

                if norm(diff(b),Inf) <= eps(norm(xCol,Inf))

                    % data are equally spaced

                    a = repmat(b,[1 prodDs]).';

                    yReorg = [3*yMat(1,:)-3*yMat(2,:)+yMat(3,:); ...

                        yMat; ...

                        3*yMat(n,:)-3*yMat(n-1,:)+yMat(n-2,:)];

                    y1 = yReorg(1:end-3,:).';

                    y2 = yReorg(2:end-2,:).';

                    y3 = yReorg(3:end-1,:).';

                    y4 = yReorg(4:end,:).';

                    breaks = xCol.';

                    page1 = (-y1+3*y2-3*y3+y4)./(2*a.^3);

                    page2 = (2*y1-5*y2+4*y3-y4)./(2*a.^2);

                    page3 = (-y1+y3)./(2*a);

                    page4 = y2;

                    coefs = cat(3,page1,page2,page3,page4);

                    pp = mkpp(breaks,coefs,ds);

                else

                    % data are not equally spaced

                    pp = spline(xCol.',reshape(yMat.',[ds, n]));

                end

            otherwise

                error('MATLAB:interp1:ppinterp:UnknownMethod', ...

                    'Unrecognized method.');

        end

        % Even if method is 'spline' or 'pchip', we still need to record that the

        % input data Y was oriented according to INTERP1's rules.

        % Thus PPVAL will return YI oriented according to INTERP1's rules and

        % YI = INTERP1(X,Y,XI,METHOD) will be the same as

        % YI = PPVAL(INTERP1(X,Y,METHOD,'pp'),XI)

        pp.orient = 'first';

    end % PPINTERP

end % INTERP1

x=[1 2 3 4 5];

y=[1.4 1.5 1.7 2.2 3];

x1=1:0.1:5;

y1=interp1(x,y,x1,'spline');

plot(x,y,'o',x1,y1,'r:');

grid on

生成后的图像为:

《CAD/CAM技术及应用》试题

阅读:2890    评论:0
  • 相关文章
  • 热门文章
  • 相关评论
网站地图

免责申明:我要玩起网旨在提供一个相互学习交流的平台,是一个完全免费的网站,部分原创作品,欢迎转载,部分内容来自互联网,如果侵犯了您的权利请尽快通知我们!邮箱:279459762@qq.com Copyright 2018-2021我要玩起网

湘ICP备17006802号-2
【电脑版】  【回到顶部】