DEMO_febio_0050_foot_insole_01
Below is a demonstration for:
- Building triangulated surface geometry for a foot
- Meshing the foot using tetrahedral elements
- Building surface model of an insole and meshing it with quads
- Extruding the surface to a thickened layer of hexahedral elements
- Defining the boundary conditions
- Coding the febio structure
- Running the model
- Importing and visualizing results
Contents
- Keywords
- Control parameters
- Import surface models
- Subdivide skin mesh and smooth
- Compute mesh derived parameters
- Reorient surfaces
- Cut skin surface
- Scale foot to desired size
- Close over top of skin
- Joining surface features
- Merge shared nodes
- Mesh foot with tetrahedral elements
- Build insole
- Joining node sets
- Define contact surfaces
- Define boundary conditions
- Set-up materials
- Convert list of materials to element id
- Defining the FEBio input structure
- Quick viewing of the FEBio input file structure
- Exporting the FEBio input file
- Running the FEBio analysis
- Export input file
- Run febio
- Set displacement magnitude in input file structure
- Export input file
- Run febio
- Importing rigid body reaction forces from a log file
- Use inter/extra-polation to guess displacement
- Import rigid body reaction forces
- Visualize force
- Plot animation
Keywords
- febio_spec version 3.0
- febio, FEBio
- shoe insole
- contact, sliding, friction
- tetrahedral elements, tet4
- hexahedral elements, hex8
- static, solid
- hyperelastic, Ogden
- displacement logfile
clear; close all; clc;
Plot settings
fontSize=15; faceAlpha1=1; faceAlpha2=0.3; markerSize1=15; markerSize2=10; lineWidth=2;
Control parameters
% Path names defaultFolder = fileparts(fileparts(mfilename('fullpath'))); savePath=fullfile(defaultFolder,'data','temp'); loadPathSurfaces=fullfile(defaultFolder,'data','STL','leg','post'); % Defining file names febioFebFileNamePart='tempModel'; febioFebFileName=fullfile(savePath,[febioFebFileNamePart,'.feb']); %FEB file name febioLogFileName=fullfile(savePath,[febioFebFileNamePart,'.txt']); %FEBio log file name febioLogFileName_disp=[febioFebFileNamePart,'_disp_out.txt']; %Log file name for exporting displacement febioLogFileName_force=[febioFebFileNamePart,'_force_out.txt']; %Log file name for exporting force febioLogFileName_strainEnergy=[febioFebFileNamePart,'_energy_out.txt']; %Log file name for exporting strain energy density % Surface model file names fileNameBones=fullfile(loadPathSurfaces,'Foot_bulk.stl'); fileNameSkin=fullfile(loadPathSurfaces,'Skin_coarse.stl'); %Geometric parameters soleOffsetOutward=3; %How much the insole protrudes outward from the foot numSmoothIterations_sole_Z=15; %Number of smoothing iterations for the sole Z value soleMinThickness=6; %Sole thickness volumeFactor=1; %Volume factor used in tetgen, larger means larger internal elements footSize=251; %Foot size in mm size 6=241 mm, size 7=251 mm % Material parameters %-> Tissue (Ogden, uncoupled) % Data source: Petre et al. 2013, Optimization of Nonlinear Hyperelastic % Coefficients for Foot Tissues Using a Magnetic Resonance Imaging % Deformation Experiment. https://dx.doi.org/10.1115%2F1.4023695 c1_1=0.02652; %Shear-modulus-like parameter in MPa m1_1=17.71; %Material parameter setting degree of non-linearity k_1=c1_1*100; %Bulk modulus %-> Sole %Sole material parameters (Ogden unconstrained, with m=2 i.e. Neo-Hookean) E_youngs_min=0.05; %Shear-modulus-like parameter in MPa E_youngs_max=0.1; %Shear-modulus-like parameter in MPa numMaterialLevels=50; %Max number of materials to use initialMaterialLevel=numMaterialLevels; E_youngs_range=linspace(E_youngs_min,E_youngs_max,numMaterialLevels); %Shear-modulus-like parameter nu=0.4; testCase=0; % Change to test different sole cases, e.g. stiff, soft, spatially varying. maxLevelColorbar_SED=0.0005; % FEA control settings numTimeSteps=10; %Number of time steps desired max_refs=25; %Max reforms max_ups=0; %Set to zero to use full-Newton iterations opt_iter=10; %Optimum number of iterations max_retries=8; %Maximum number of retires dtmin=(1/numTimeSteps)/100; %Minimum time step size dtmax=1/numTimeSteps; %Maximum time step size symmetric_stiffness=0; min_residual=1e-20; runMode='internal'; initialSoleSpacing=0.1; %Boundary condition parameters displacementMagnitude=-2.63; %Displacement applied to the bones bodyWeight=65/2;% Body weight in Kg forceBody=bodyWeight.*-9.81; %Force due to body weight forceDifferenceToleranceFraction=0.05; forceDifferenceTolerance=abs(forceBody.*forceDifferenceToleranceFraction); optimizeForceOption=0; %set to 0 to turn off and use input displacement maxProposedDisplacementDifference=1; %Contact parameters contactPenalty=10; laugon=0; minaug=1; maxaug=10; fric_coeff=0.25;
Import surface models
%Import STL file for the bones [stlStruct] = import_STL(fileNameBones); F1=stlStruct.solidFaces{1}; %Faces V1=stlStruct.solidVertices{1}; %Vertices [F1,V1]=mergeVertices(F1,V1); %Merge nodes %Import STL file for the skin [stlStruct] = import_STL(fileNameSkin); F2=stlStruct.solidFaces{1}; %Faces V2=stlStruct.solidVertices{1}; %Vertices [F2,V2]=mergeVertices(F2,V2); %Merge nodes V2=V2*100; %Scale
Subdivide skin mesh and smooth
% %Split elements once % [F2,V2]=subtri(F2,V2,1); % % %Smooth % clear cParSmooth; % cParSmooth.n=5; % cParSmooth.Method='HC'; % [V2]=patchSmooth(F2,V2,[],cParSmooth);
Visualize imported surfaces
cFigure; hold on; gpatch(F1,V1,'bw','none',1); gpatch(F2,V2,'rw','none',0.5); camlight('headlight'); axisGeom(gca,fontSize); drawnow;

Compute mesh derived parameters
Compute point spacings for the surfaces meshes. These are useful to relate other mesh sizes to.
pointSpacing1=mean(patchEdgeLengths(F1,V1)); pointSpacing2=mean(patchEdgeLengths(F2,V2)); pointSpacing=mean([pointSpacing1 pointSpacing2]); pointSpacingSole=pointSpacing;
Reorient surfaces
Reorient so that the leg points up in a forward view with the toes pointing towards the viewer.
R=euler2DCM([-0.5*pi 0 -0.5*pi]); V1=V1*R; V2=V2*R;
Visualize reoriented surfaces
cFigure; hold on; gpatch(F1,V1,'bw','none',1); gpatch(F2,V2,'rw','none',0.5); camlight('headlight'); axisGeom(gca,fontSize); drawnow;

Cut skin surface
The skin surface is cut such that it stops where the bones of the ankle end in the z direction.
%Create a logic for cutting away faces max_Z1=max(V1(:,3))+2*pointSpacing; %Max Z-level used for cutting logicVertices=V2(:,3)<max_Z1; %Logic for the points below this level logicFaces=all(logicVertices(F2),2); %Logic for the faces logicFaces=triSurfLogicSharpFix(F2,logicFaces,3); %Altered logic so it is smoother
Visualize
cFigure; hold on; gpatch(F1,V1,'bw','none',1); gpatch(F2,V2,logicFaces,'none',0.5); camlight('headlight'); axisGeom(gca,fontSize); drawnow;

Cut away faces using logic
F2=F2(logicFaces,:); %The faces to keep [F2,V2]=patchCleanUnused(F2,V2); %Remove unused points %Attempt to self triangulate potentially jagged edge Eb=patchBoundary(F2,V2); %Get boundary edges indBoundary=edgeListToCurve(Eb); %Convert boundary edges to a curve list indBoundary=indBoundary(1:end-1); %Trim off last point since it is equal to first on a closed loop angleThreshold=pi*(120/180); %threshold for self triangulation [F2,V2,indBoundaryTop]=triSurfSelfTriangulateBoundary(F2,V2,indBoundary,angleThreshold,1); %Force boundary to have the max Z level chosen V2(indBoundaryTop,3)=max_Z1;
Visualize
cFigure; hold on; gpatch(F1,V1,'bw','none',1); gpatch(F2,V2,'rw','k',0.5); plotV(V2(indBoundaryTop,:),'r-','LineWidth',lineWidth); camlight('headlight'); axisGeom(gca,fontSize); drawnow;

Scale foot to desired size
currentFootSize=abs(max(V2(:,1))-min(V2(:,1))); V2=V2./currentFootSize; %Scale to unit foot V2=V2.*footSize; %Scale to desired foot size V1=V1./currentFootSize; %Scale to unit foot V1=V1.*footSize; %Scale to desired foot size
Close over top of skin
The top boundary curve of the cut surface is filled with triangles. This is a 2D method. The z-coordinate is added after.
[F2t,V2t]=regionTriMesh2D({V2(indBoundaryTop,[1 2])},pointSpacing2,0,0);
V2t(:,3)=mean(V2(indBoundaryTop,3)); %Add/set z-level
Visualize
cFigure; hold on; gpatch(F1,V1,'bw','none',1); gpatch(F2,V2,'rw','k',0.5); gpatch(F2t,V2t,'gw','k',1); plotV(V2(indBoundaryTop,:),'r-','LineWidth',lineWidth); camlight('headlight'); axisGeom(gca,fontSize); drawnow;

Joining surface features
Add all surface sets together in joint list of faces, vertices
[FT,VT,CT]=joinElementSets({F1,F2,F2t},{V1,V2,V2t});
Merge shared nodes
The join operation only adds the sets together. Nodes with the same coordinates are not seen as the same yet and need to be merged.
[FT,VT]=mergeVertices(FT,VT); %Merge nodes
Visualize
cFigure; hold on; gpatch(FT,VT,CT,'k',0.5); patchNormPlot(FT,VT); camlight('headlight'); axisGeom(gca,fontSize); colormap gjet; icolorbar; drawnow;

Mesh foot with tetrahedral elements
Tet meshing is based on tetgen. TetGen requires a interior points for regions to be meshed, as well as intertior points for holes.
Define region points
[V_region]=getInnerPoint({FT(CT==2 | CT==3,:),FT(CT==1,:)},{VT,VT}); [V_hole]=getInnerPoint(FT(CT==1,:),VT);
Visualize interior points
cFigure; hold on; gpatch(FT,VT,'kw','none',0.2); hp1=plotV(V_region,'r.','markerSize',markerSize1); hp2=plotV(V_hole,'b.','markerSize',markerSize1); legend([hp1 hp2],{'Region point','Hole point'}); camlight('headlight'); axisGeom(gca,fontSize); drawnow;

Mesh using tetgen
inputStruct.stringOpt='-pq1.2AaY'; %TetGen option string inputStruct.Faces=FT; %The faces inputStruct.Nodes=VT; %The vertices inputStruct.holePoints=V_hole; %The hole interior points inputStruct.faceBoundaryMarker=CT; %Face boundary markers inputStruct.regionPoints=V_region; %The region interior points inputStruct.regionA=tetVolMeanEst(F2,V2)*volumeFactor; %Volume for regular tets
Mesh model using tetrahedral elements using tetGen
[meshOutput]=runTetGen(inputStruct); %Run tetGen
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% --- TETGEN Tetrahedral meshing --- 29-Apr-2021 14:17:30 %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% --- Writing SMESH file --- 29-Apr-2021 14:17:30 ----> Adding node field ----> Adding facet field ----> Adding holes specification ----> Adding region specification --- Done --- 29-Apr-2021 14:17:30 --- Running TetGen to mesh input boundary--- 29-Apr-2021 14:17:30 Opening /mnt/data/MATLAB/GIBBON/data/temp/temp.smesh. Delaunizing vertices... Delaunay seconds: 0.032427 Creating surface mesh ... Surface mesh seconds: 0.011654 Recovering boundaries... Boundary recovery seconds: 0.026949 Removing exterior tetrahedra ... Spreading region attributes. Exterior tets removal seconds: 0.014912 Recovering Delaunayness... Delaunay recovery seconds: 0.012949 Refining mesh... 8715 insertions, added 4031 points, 77756 tetrahedra in queue. 2902 insertions, added 247 points, 322 tetrahedra in queue. Refinement seconds: 0.194062 Smoothing vertices... Mesh smoothing seconds: 0.260542 Improving mesh... Mesh improvement seconds: 0.010571 Writing /mnt/data/MATLAB/GIBBON/data/temp/temp.1.node. Writing /mnt/data/MATLAB/GIBBON/data/temp/temp.1.ele. Writing /mnt/data/MATLAB/GIBBON/data/temp/temp.1.face. Writing /mnt/data/MATLAB/GIBBON/data/temp/temp.1.edge. Output seconds: 0.147681 Total running seconds: 0.712194 Statistics: Input points: 6538 Input facets: 13068 Input segments: 19602 Input holes: 1 Input regions: 1 Mesh points: 10924 Mesh tetrahedra: 47602 Mesh faces: 101738 Mesh faces on exterior boundary: 13068 Mesh faces on input facets: 13068 Mesh edges on input segments: 19602 Steiner points inside domain: 4386 --- Done --- 29-Apr-2021 14:17:31 %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% --- Importing TetGen files --- 29-Apr-2021 14:17:31 --- Done --- 29-Apr-2021 14:17:32
Access model element and patch data
Fb_foot=meshOutput.facesBoundary; %Boundary faces of the foot Cb_foot=meshOutput.boundaryMarker; %Boundary marker/color data for the foot V_foot=meshOutput.nodes; %The vertices/nodes E_foot=meshOutput.elements; %The tet4 elements
Visualizing mesh using meshView, see also anim8
meshView(meshOutput);

Build insole
The insole is created by taking the 2D convex hull of the foot (ignoring the z-direction). Next this convex hull is resampled and filled with triangular elements. The z-coordinates are then based on the nearest foot nodes. The z-coordinate data is next smoothed to create a smooth surface. This surface is next thickened to form hexahedral elements.
Create sole boundary curve in 2D
% Offset surface outward to thicken so sole is enlarged outward [~,~,Nv]=patchNormal(FT,VT); VT_sole=VT+soleOffsetOutward.*Nv; P=VT_sole(:,[1 2]); %Point set flattened to 2D DT=delaunayTriangulation(P); %Delaunay triangulation of 2D set VD=DT.Points; %Delaunay point set VD(:,3)=min(VT(:,3)); %Set z-coord to minimum for now indChull=DT.convexHull; %Ordered point list for conhex hull indChull=indChull(1:end-1); %Trim away last (=start) point to avoid double V_chull=VD(indChull,:); %Vertices for convex hull D=max(pathLength(V_chull)); %Get length of sole curve for resampling numResample=ceil(D./pointSpacingSole); V_sole_curve=evenlySampleCurve(V_chull,numResample,'pchip',1);
Visualize
cFigure; hold on; gpatch(FT,VT,'kw','none',0.25); plotV(P,'k.','MarkerSize',markerSize2); plotV(V_chull,'r.','MarkerSize',markerSize1*2); plotV(V_sole_curve,'b.-','MarkerSize',markerSize1,'LineWidth',lineWidth); camlight('headlight'); axisGeom(gca,fontSize); colormap gjet; icolorbar; drawnow;

Build sole top surface
[F_sole_top,V_sole_top]=regionTriMesh2D({V_sole_curve(:,[1 2])},pointSpacingSole,0,0); V_sole_top(:,3)=mean(V_sole_curve(:,3)); Eb=patchBoundary(F_sole_top,V_sole_top); indBoundary=unique(Eb(:)); %Get z-coordinate [~,indMin]=minDist(V_sole_top,VT); V_sole_top(:,3)=VT(indMin,3); %Free smoothing of boundary clear cParSmooth; cParSmooth.n=numSmoothIterations_sole_Z; cParSmooth.Method='LAP'; [p]=patchSmooth(Eb,V_sole_top,[],cParSmooth); V_sole_top(indBoundary,3)=p(indBoundary,3); % Constrained general smoothing cParSmooth.n=numSmoothIterations_sole_Z; cParSmooth.Method='LAP'; cParSmooth.RigidConstraints=indBoundary; [V_sole_top(:,3)]=patchSmooth(F_sole_top,V_sole_top(:,3),[],cParSmooth); %Shift a small amount to there is no initial contact [~,indMin]=minDist(V_sole_top,VT); dz=VT(indMin,3)-V_sole_top(:,3); V_sole_top(:,3)=V_sole_top(:,3)-abs(min(dz)); V_sole_top(:,3)=V_sole_top(:,3)-initialSoleSpacing;
Visualize
cFigure; hold on; gpatch(FT,VT,'kw','none',0.25); gpatch(F_sole_top,V_sole_top,'gw','k',1); patchNormPlot(F_sole_top,V_sole_top); camlight('headlight'); axisGeom(gca,fontSize); colormap gjet; icolorbar; drawnow;

Create bottom surface of sole
dirSet=[0 0 -1]; numElementsSoleThickness=ceil(soleMinThickness./pointSpacingSole); [E_sole,V_sole,F_sole_top,F_sole_bottom]=patchThick(fliplr(F_sole_top),V_sole_top,dirSet,soleMinThickness,numElementsSoleThickness); F_sole_top=fliplr(F_sole_top); % Use element2patch to get patch data F_E_sole=element2patch(E_sole,[],'penta6'); % indBoundaryFaces=tesBoundary(F_E_sole,V_sole); % Fb_sole=F_E_sole(indBoundaryFaces,:);
cFigure; hold on; gpatch(FT,VT,'kw','none',0.25); gpatch(F_sole_top,V_sole,'gw','k',1); gpatch(F_sole_bottom,V_sole,'bw','k',1); patchNormPlot(F_sole_top,V_sole); camlight('headlight'); axisGeom(gca,fontSize); colormap gjet; icolorbar; drawnow;

Visualize
cFigure; hold on; title('Hexahedral mesh'); gpatch(FT,VT,'kw','none',0.25); gpatch(F_E_sole,V_sole,'bw','k',1); % patchNormPlot(Fb_sole,V_sole); axisGeom; camlight headlight; drawnow;

Joining node sets
V=[V_foot;V_sole;]; %Combined node sets E_sole=E_sole+size(V_foot,1); %Fixed element indices F_sole_top=F_sole_top+size(V_foot,1); %Fixed element indices F_sole_bottom=F_sole_bottom+size(V_foot,1); %Fixed indices F_E_sole=element2patch(E_sole,[],'penta6');
Visualize
cFigure; hold on; title('Hexahedral mesh'); gpatch(Fb_foot,V,Cb_foot,'k',1); gpatch(F_sole_top,V,'kw','k',1); gpatch(F_sole_bottom,V,'kw','k',1); % patchNormPlot(FEs,V); colormap gjet; icolorbar; axisGeom; camlight headlight; drawnow;

Define contact surfaces
% The rigid primary surface of the sphere F_contact_primary=F_sole_top; % The deformable secondary surface of the slab F_contact_secondary=fliplr(Fb_foot(Cb_foot==2,:));
Visualize contact surfaces
cFigure; hold on; title('Contact sets and normal directions','FontSize',fontSize); gpatch(Fb_foot,V,'kw','none',faceAlpha2); % gpatch(Fb_sole,V,'kw','none',faceAlpha2); hl(1)=gpatch(F_contact_primary,V,'gw','k',1); patchNormPlot(F_contact_primary,V); hl(2)=gpatch(F_contact_secondary,V,'bw','k',1); patchNormPlot(F_contact_secondary,V); legend(hl,{'Primary','Secondary'}); axisGeom(gca,fontSize); camlight headlight; drawnow;

Define boundary conditions
%Supported nodes bcSupportList=unique(F_sole_bottom); %Prescribed displacement nodes bcPrescribeList=unique(Fb_foot(Cb_foot==1,:));
Visualize BC's
hf=cFigure; hold on; title('Boundary conditions model','FontSize',fontSize); gpatch(Fb_foot,V,'kw','none',faceAlpha2); hl2(1)=plotV(V(bcPrescribeList,:),'r.','MarkerSize',markerSize2); hl2(2)=plotV(V(bcSupportList,:),'k.','MarkerSize',markerSize2); legend(hl2,{'BC prescribe','BC support'}); axisGeom(gca,fontSize); camlight headlight; drawnow;

Visualize rigid body bone surface elements
F_bone=Fb_foot(Cb_foot==1,:); center_of_mass_bone=mean(V(bcPrescribeList,:),1); cFigure; hold on; % title('Boundary conditions model','FontSize',fontSize); gpatch(Fb_foot,V,'kw','none',faceAlpha2); gpatch(F_bone,V,'w','k',1); axisGeom(gca,fontSize); camlight headlight; drawnow;

Set-up materials
switch testCase case 0 %Spatially varying based on bone distance VE=patchCentre(E_sole,V); %Element centres V_vulnerable=VT(bcPrescribeList,:); W=minDist(VE,V_vulnerable); %Distance to bone points W=W-min(W(:)); W=W./max(W(:)); W=W.*(E_youngs_max-E_youngs_min); W=W+E_youngs_min; E_youngs_desired=W; case 1 % E_youngs_desired=E_youngs_max*ones(size(E_sole,1),1); case 2 E_youngs_desired=(E_youngs_max+E_youngs_min)/2*ones(size(E_sole,1),1); case 3 E_youngs_desired=E_youngs_min*ones(size(E_sole,1),1); end %Snap to nearest available materials [~,elementMaterialID]=minDist(E_youngs_desired(:),E_youngs_range(:));
Visualize material levels
%Use element2patch to get patch and color data [F_E_sole,C_F_E_sole]=element2patch(E_sole,elementMaterialID,'penta6'); hf=cFigure; hold on; title('Material levels','FontSize',fontSize); gpatch(Fb_foot(Cb_foot==1,:),V,'kw','none',1); gpatch(Fb_foot(Cb_foot~=1,:),V,'w','none',0.5); for q=1:1:numel(F_E_sole) gpatch(F_E_sole{q},V,C_F_E_sole{q},'k',1); end axisGeom(gca,fontSize); camlight headlight; colormap parula; icolorbar; %caxis([0 maxLevelColorbar_SED]); drawnow;

Convert list of materials to element id
%Sorting elements according to material label [elementMaterialID,indSortElements]=sort(elementMaterialID); E_sole=E_sole(indSortElements,:); %Removing unused materials [indUsed,ind1,ind2]=unique(elementMaterialID(:)); elementMaterialID=ind2; E_youngs_set=E_youngs_range(indUsed); numMaterials=numel(indUsed); E_youngs_elem=E_youngs_set(elementMaterialID);
Defining the FEBio input structure
See also febioStructTemplate and febioStruct2xml and the FEBio user manual.
%Get a template with default settings [febio_spec]=febioStructTemplate; %febio_spec version febio_spec.ATTR.version='3.0'; %Module section febio_spec.Module.ATTR.type='solid'; %Control section febio_spec.Control.analysis='STATIC'; febio_spec.Control.time_steps=numTimeSteps; febio_spec.Control.step_size=1/numTimeSteps; febio_spec.Control.solver.max_refs=max_refs; febio_spec.Control.solver.max_ups=max_ups; febio_spec.Control.solver.symmetric_stiffness=symmetric_stiffness; % febio_spec.Control.solver.min_residual=min_residual; febio_spec.Control.time_stepper.dtmin=dtmin; febio_spec.Control.time_stepper.dtmax=dtmax; febio_spec.Control.time_stepper.max_retries=max_retries; febio_spec.Control.time_stepper.opt_iter=opt_iter; %Material section materialName1='Material1'; febio_spec.Material.material{1}.ATTR.name=materialName1; febio_spec.Material.material{1}.ATTR.type='Ogden'; febio_spec.Material.material{1}.ATTR.id=1; febio_spec.Material.material{1}.c1=c1_1; febio_spec.Material.material{1}.m1=m1_1; febio_spec.Material.material{1}.k=k_1; materialName2='Material2'; febio_spec.Material.material{2}.ATTR.name=materialName2; febio_spec.Material.material{2}.ATTR.type='rigid body'; febio_spec.Material.material{2}.ATTR.id=2; febio_spec.Material.material{2}.density=1; febio_spec.Material.material{2}.center_of_mass=center_of_mass_bone; materialName3='Material3'; dataMapName='MaterialParameterMap'; febio_spec.Material.material{3}.ATTR.name=materialName3; febio_spec.Material.material{3}.ATTR.type='neo-Hookean'; febio_spec.Material.material{3}.ATTR.id=3; febio_spec.Material.material{3}.E.ATTR.type='map'; %Calls for mapping of parameter febio_spec.Material.material{3}.E=dataMapName; %Calls for mapping of parameter febio_spec.Material.material{3}.v=nu; % Mesh section % -> Nodes febio_spec.Mesh.Nodes{1}.ATTR.name='Object1'; %The node set name febio_spec.Mesh.Nodes{1}.node.ATTR.id=(1:size(V,1))'; %The node id's febio_spec.Mesh.Nodes{1}.node.VAL=V; %The nodel coordinates % -> Elements partName1='Part1'; febio_spec.Mesh.Elements{1}.ATTR.name=partName1; %Name of this part febio_spec.Mesh.Elements{1}.ATTR.type='tet4'; %Element type febio_spec.Mesh.Elements{1}.elem.ATTR.id=(1:1:size(E_foot,1))'; %Element id's febio_spec.Mesh.Elements{1}.elem.VAL=E_foot; %The element matrix partName2='Part2'; febio_spec.Mesh.Elements{2}.ATTR.name=partName2; %Name of this part febio_spec.Mesh.Elements{2}.ATTR.type='tri3'; %Element type febio_spec.Mesh.Elements{2}.elem.ATTR.id=size(E_foot,1)+(1:1:size(F_bone,1))'; %Element id's febio_spec.Mesh.Elements{2}.elem.VAL=F_bone; %The element matrix partName3='Part3'; febio_spec.Mesh.Elements{3}.ATTR.name=partName3; %Name of this part febio_spec.Mesh.Elements{3}.ATTR.type='penta6'; %Element type febio_spec.Mesh.Elements{3}.elem.ATTR.id=size(E_foot,1)+size(F_bone,1)+(1:1:size(E_sole,1))'; %Element id's febio_spec.Mesh.Elements{3}.elem.VAL=E_sole; %The element matrix % -> NodeSets nodeSetName1='bcSupportList'; nodeSetName2='bcPrescribeList'; febio_spec.Mesh.NodeSet{1}.ATTR.name=nodeSetName1; febio_spec.Mesh.NodeSet{1}.node.ATTR.id=bcSupportList(:); febio_spec.Mesh.NodeSet{2}.ATTR.name=nodeSetName2; febio_spec.Mesh.NodeSet{2}.node.ATTR.id=bcPrescribeList(:); % -> Surfaces surfaceName1='contactSurface1'; febio_spec.Mesh.Surface{1}.ATTR.name=surfaceName1; febio_spec.Mesh.Surface{1}.tri3.ATTR.id=(1:1:size(F_contact_secondary,1))'; febio_spec.Mesh.Surface{1}.tri3.VAL=F_contact_secondary; surfaceName2='contactSurface2'; febio_spec.Mesh.Surface{2}.ATTR.name=surfaceName2; febio_spec.Mesh.Surface{2}.tri3.ATTR.id=(1:1:size(F_contact_primary,1))'; febio_spec.Mesh.Surface{2}.tri3.VAL=F_contact_primary; % -> Surface pairs contactPairName='Contact1'; febio_spec.Mesh.SurfacePair{1}.ATTR.name=contactPairName; febio_spec.Mesh.SurfacePair{1}.primary=surfaceName2; febio_spec.Mesh.SurfacePair{1}.secondary=surfaceName1; %MeshData secion %-> Element data febio_spec.MeshData.ElementData.ATTR.name=dataMapName; febio_spec.MeshData.ElementData.ATTR.elem_set=partName3; febio_spec.MeshData.ElementData.elem.ATTR.lid=(1:1:size(E_sole,1))'; febio_spec.MeshData.ElementData.elem.VAL=E_youngs_elem(:); %MeshDomains section febio_spec.MeshDomains.SolidDomain{1}.ATTR.name=partName1; febio_spec.MeshDomains.SolidDomain{1}.ATTR.mat=materialName1; febio_spec.MeshDomains.ShellDomain.ATTR.name=partName2; febio_spec.MeshDomains.ShellDomain.ATTR.mat=materialName2; febio_spec.MeshDomains.SolidDomain{2}.ATTR.name=partName3; febio_spec.MeshDomains.SolidDomain{2}.ATTR.mat=materialName3; %Boundary condition section % -> Fix boundary conditions febio_spec.Boundary.bc{1}.ATTR.type='fix'; febio_spec.Boundary.bc{1}.ATTR.node_set=nodeSetName1; febio_spec.Boundary.bc{1}.dofs='x,y,z'; %Rigid section % ->Rigid body fix boundary conditions febio_spec.Rigid.rigid_constraint{1}.ATTR.name='RigidFix_1'; febio_spec.Rigid.rigid_constraint{1}.ATTR.type='fix'; febio_spec.Rigid.rigid_constraint{1}.rb=2; febio_spec.Rigid.rigid_constraint{1}.dofs='Rx,Ry'; % ->Rigid body prescribe boundary conditions febio_spec.Rigid.rigid_constraint{2}.ATTR.name='RigidPrescribe'; febio_spec.Rigid.rigid_constraint{2}.ATTR.type='prescribe'; febio_spec.Rigid.rigid_constraint{2}.rb=2; febio_spec.Rigid.rigid_constraint{2}.dof='Rz'; febio_spec.Rigid.rigid_constraint{2}.value.ATTR.lc=1; febio_spec.Rigid.rigid_constraint{2}.value.VAL=displacementMagnitude; febio_spec.Rigid.rigid_constraint{2}.relative=0; %Contact section febio_spec.Contact.contact{1}.ATTR.type='sliding-elastic'; febio_spec.Contact.contact{1}.ATTR.surface_pair=contactPairName; febio_spec.Contact.contact{1}.two_pass=0; febio_spec.Contact.contact{1}.laugon=laugon; febio_spec.Contact.contact{1}.tolerance=0.2; febio_spec.Contact.contact{1}.gaptol=0; febio_spec.Contact.contact{1}.minaug=minaug; febio_spec.Contact.contact{1}.maxaug=maxaug; febio_spec.Contact.contact{1}.search_tol=0.01; febio_spec.Contact.contact{1}.search_radius=0.1; febio_spec.Contact.contact{1}.symmetric_stiffness=0; febio_spec.Contact.contact{1}.auto_penalty=1; febio_spec.Contact.contact{1}.penalty=contactPenalty; febio_spec.Contact.contact{1}.fric_coeff=fric_coeff; %LoadData section % -> load_controller febio_spec.LoadData.load_controller{1}.ATTR.id=1; febio_spec.LoadData.load_controller{1}.ATTR.type='loadcurve'; febio_spec.LoadData.load_controller{1}.interpolate='LINEAR'; febio_spec.LoadData.load_controller{1}.points.point.VAL=[0 0; 1 1]; %Output section % -> log file febio_spec.Output.logfile.ATTR.file=febioLogFileName; febio_spec.Output.logfile.node_data{1}.ATTR.file=febioLogFileName_disp; febio_spec.Output.logfile.node_data{1}.ATTR.data='ux;uy;uz'; febio_spec.Output.logfile.node_data{1}.ATTR.delim=','; febio_spec.Output.logfile.node_data{1}.VAL=1:size(V,1); febio_spec.Output.logfile.rigid_body_data{1}.ATTR.file=febioLogFileName_force; febio_spec.Output.logfile.rigid_body_data{1}.ATTR.data='Fx;Fy;Fz'; febio_spec.Output.logfile.rigid_body_data{1}.ATTR.delim=','; febio_spec.Output.logfile.rigid_body_data{1}.VAL=2; febio_spec.Output.logfile.element_data{1}.ATTR.file=febioLogFileName_strainEnergy; febio_spec.Output.logfile.element_data{1}.ATTR.data='sed'; febio_spec.Output.logfile.element_data{1}.ATTR.delim=','; febio_spec.Output.logfile.element_data{1}.VAL=1:size(E_foot,1);
Quick viewing of the FEBio input file structure
The febView function can be used to view the xml structure in a MATLAB figure window.
febView(febio_spec); %Viewing the febio file
Exporting the FEBio input file
Exporting the febio_spec structure to an FEBio input file is done using the febioStruct2xml function.
febioStruct2xml(febio_spec,febioFebFileName); %Exporting to file and domNode
Running the FEBio analysis
To run the analysis defined by the created FEBio input file the runMonitorFEBio function is used. The input for this function is a structure defining job settings e.g. the FEBio input file name. The optional output runFlag informs the user if the analysis was run succesfully.
febioAnalysis.run_filename=febioFebFileName; %The input file name febioAnalysis.run_logname=febioLogFileName; %The name for the log file febioAnalysis.disp_on=1; %Display information on the command window febioAnalysis.runMode='internal';%'internal'; [runFlag]=runMonitorFEBio(febioAnalysis);%START FEBio NOW!!!!!!!!
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% --------> RUNNING/MONITORING FEBIO JOB <-------- 29-Apr-2021 14:17:52 FEBio path: /home/kevin/FEBioStudio/bin/febio3 # Attempt removal of existing log files 29-Apr-2021 14:17:52 * Removal succesful 29-Apr-2021 14:17:52 # Attempt removal of existing .xplt files 29-Apr-2021 14:17:52 * Removal succesful 29-Apr-2021 14:17:52 # Starting FEBio... 29-Apr-2021 14:17:52 Max. total analysis time is: Inf s =========================================================================== ________ _________ _______ __ _________ | |\ | |\ | \\ | |\ / \\ | ____|| | ____|| | __ || |__|| | ___ || | |\___\| | |\___\| | |\_| || \_\| | // \ || | ||__ | ||__ | ||_| || | |\ | || | || | |\ | |\ | \\ | || | || | || | ___|| | ___|| | ___ || | || | || | || | |\__\| | |\__\| | |\__| || | || | || | || | || | ||___ | ||__| || | || | \\__/ || | || | |\ | || | || | || |___|| |________|| |_________// |__|| \_________// F I N I T E E L E M E N T S F O R B I O M E C H A N I C S version 3.3.3 FEBio is a registered trademark. copyright (c) 2006-2020 - All rights reserved =========================================================================== Default linear solver: pardiso Success loading plugin libFEBioChem.so (version 1.0.0) Success loading plugin libFEBioHeat.so (version 1.0.0) Reading file /mnt/data/MATLAB/GIBBON/data/temp/tempModel.feb ...SUCCESS! Setting parameter "value" to : -0 ]0;(0%) tempModel.feb - FEBio 3.3.3 ===== beginning time step 1 : 0.1 ===== Setting parameter "value" to : -0.263 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1038640 1 Nonlinear solution status: time= 0.1 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329175e+09 3.828500e-04 0.000000e+00 energy 1.403759e+03 4.854666e-07 1.403759e+01 displacement 4.091794e+02 4.091794e+02 4.091794e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1038640 2 Nonlinear solution status: time= 0.1 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329175e+09 3.612058e-18 0.000000e+00 energy 1.403759e+03 3.695740e-18 1.403759e+01 displacement 4.091794e+02 6.268953e-12 4.091794e-04 convergence summary number of iterations : 2 number of reformations : 2 ------- converged at time : 0.1 Data Record #1 =========================================================================== Step = 1 Time = 0.1 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 1 Time = 0.1 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 1 Time = 0.1 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(10%) tempModel.feb - FEBio 3.3.3 ===== beginning time step 2 : 0.2 ===== Setting parameter "value" to : -0.526 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1038640 1 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 1.402423e-01 0.000000e+00 energy 1.403763e+03 1.531771e-01 1.403763e+01 displacement 4.096069e+02 4.096069e+02 4.096069e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039972 2 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 2.137298e+01 0.000000e+00 energy 1.403763e+03 4.300414e-03 1.403763e+01 displacement 4.096069e+02 4.651895e+00 4.314619e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039738 3 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 8.247087e-01 0.000000e+00 energy 1.403763e+03 1.193130e-04 1.403763e+01 displacement 4.096069e+02 5.527664e-01 4.391668e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039648 4 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 1.732131e-01 0.000000e+00 energy 1.403763e+03 1.897806e-05 1.403763e+01 displacement 4.096069e+02 2.858720e-01 4.416154e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 5 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 7.022242e-03 0.000000e+00 energy 1.403763e+03 1.351346e-04 1.403763e+01 displacement 4.096069e+02 8.497094e-02 4.427311e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 6 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 6 step from line search = 0.539828 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 2.166038e-02 0.000000e+00 energy 1.403763e+03 1.244470e-06 1.403763e+01 displacement 4.096069e+02 1.117095e-01 4.418795e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 7 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 3.831882e-04 0.000000e+00 energy 1.403763e+03 1.629448e-05 1.403763e+01 displacement 4.096069e+02 2.678004e-02 4.421439e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 8 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 8 step from line search = 0.179328 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 3.409866e-04 0.000000e+00 energy 1.403763e+03 1.877516e-06 1.403763e+01 displacement 4.096069e+02 2.700480e-03 4.420126e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 9 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 9 step from line search = 0.535304 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 1.415186e-04 0.000000e+00 energy 1.403763e+03 1.455539e-06 1.403763e+01 displacement 4.096069e+02 1.888585e-03 4.418911e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 10 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 10 step from line search = 0.621608 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 5.575567e-05 0.000000e+00 energy 1.403763e+03 3.563397e-05 1.403763e+01 displacement 4.096069e+02 1.992046e-03 4.423070e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 11 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 11 step from line search = 0.511708 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 7.306995e-05 0.000000e+00 energy 1.403763e+03 4.074807e-06 1.403763e+01 displacement 4.096069e+02 3.855771e-03 4.418988e-04 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 12 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 4.015679e-06 0.000000e+00 energy 1.403763e+03 4.470743e-06 1.403763e+01 displacement 4.096069e+02 1.724052e-03 4.419694e-04 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 13 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 23 stiffness matrix reformations = 13 step from line search = 0.178956 convergence norms : INITIAL CURRENT REQUIRED residual 3.329104e+09 2.355273e-06 0.000000e+00 energy 1.403763e+03 3.709430e-07 1.403763e+01 displacement 4.096069e+02 1.397946e-04 4.419364e-04 convergence summary number of iterations : 13 number of reformations : 13 ------- converged at time : 0.2 Data Record #1 =========================================================================== Step = 2 Time = 0.2 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 2 Time = 0.2 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 2 Time = 0.2 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(20%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: decreasing time step, dt = 0.0878287 ===== beginning time step 3 : 0.287829 ===== Setting parameter "value" to : -0.75699 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 1 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 2.009019e+03 0.000000e+00 energy 1.082818e+03 9.358888e-01 1.082818e+01 displacement 3.703242e+02 3.703242e+02 3.703242e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1042042 2 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 1.874311e+02 0.000000e+00 energy 1.082818e+03 2.982771e-02 1.082818e+01 displacement 3.703242e+02 9.220630e+00 3.682200e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041718 3 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 3.599290e+00 0.000000e+00 energy 1.082818e+03 1.349683e-03 1.082818e+01 displacement 3.703242e+02 1.358264e+00 3.696485e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041286 4 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 4.585564e-01 0.000000e+00 energy 1.082818e+03 2.367694e-04 1.082818e+01 displacement 3.703242e+02 4.583685e-01 3.726229e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1040998 5 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 3.118974e-03 0.000000e+00 energy 1.082818e+03 4.975860e-05 1.082818e+01 displacement 3.703242e+02 4.138548e-02 3.741494e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1040962 6 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 1.804980e-04 0.000000e+00 energy 1.082818e+03 2.925702e-05 1.082818e+01 displacement 3.703242e+02 9.626672e-03 3.736328e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041088 7 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 1.276852e-04 0.000000e+00 energy 1.082818e+03 6.244803e-05 1.082818e+01 displacement 3.703242e+02 1.675524e-03 3.732271e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041196 8 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 2.537061e-04 0.000000e+00 energy 1.082818e+03 8.360953e-05 1.082818e+01 displacement 3.703242e+02 6.938506e-03 3.722833e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041124 9 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 5.052518e-02 0.000000e+00 energy 1.082818e+03 5.926847e-05 1.082818e+01 displacement 3.703242e+02 1.948331e-01 3.680297e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041124 10 Nonlinear solution status: time= 0.287829 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.569847e+09 1.545778e-08 0.000000e+00 energy 1.082818e+03 4.318131e-08 1.082818e+01 displacement 3.703242e+02 7.597614e-05 3.679987e-04 convergence summary number of iterations : 10 number of reformations : 10 ------- converged at time : 0.287829 Data Record #1 =========================================================================== Step = 3 Time = 0.287828744 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 3 Time = 0.287828744 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 3 Time = 0.287828744 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(29%) tempModel.feb - FEBio 3.3.3 ===== beginning time step 4 : 0.375657 ===== Setting parameter "value" to : -0.987979 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041088 1 Nonlinear solution status: time= 0.375657 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.571718e+09 2.228923e+03 0.000000e+00 energy 1.082338e+03 1.008039e+00 1.082338e+01 displacement 3.741572e+02 3.741572e+02 3.741572e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1045030 2 Nonlinear solution status: time= 0.375657 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.571718e+09 6.675497e+01 0.000000e+00 energy 1.082338e+03 2.148556e-02 1.082338e+01 displacement 3.741572e+02 6.445638e+00 3.523282e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1044400 3 Nonlinear solution status: time= 0.375657 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.571718e+09 4.649763e-02 0.000000e+00 energy 1.082338e+03 3.670245e-04 1.082338e+01 displacement 3.741572e+02 1.966177e-01 3.492814e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1044166 4 Nonlinear solution status: time= 0.375657 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.571718e+09 5.596598e-04 0.000000e+00 energy 1.082338e+03 9.900162e-05 1.082338e+01 displacement 3.741572e+02 1.729695e-02 3.481277e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1044112 5 Nonlinear solution status: time= 0.375657 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.571718e+09 4.746498e-04 0.000000e+00 energy 1.082338e+03 6.426650e-05 1.082338e+01 displacement 3.741572e+02 1.973295e-02 3.472422e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1044022 6 Nonlinear solution status: time= 0.375657 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.571718e+09 3.313032e-06 0.000000e+00 energy 1.082338e+03 5.427310e-06 1.082338e+01 displacement 3.741572e+02 1.309900e-03 3.470592e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1044022 7 Nonlinear solution status: time= 0.375657 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.571718e+09 9.418292e-09 0.000000e+00 energy 1.082338e+03 1.538300e-08 1.082338e+01 displacement 3.741572e+02 2.927789e-06 3.470658e-04 convergence summary number of iterations : 7 number of reformations : 7 ------- converged at time : 0.375657 Data Record #1 =========================================================================== Step = 4 Time = 0.375657488 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 4 Time = 0.375657488 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 4 Time = 0.375657488 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(38%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0902049 ===== beginning time step 5 : 0.465862 ===== Setting parameter "value" to : -1.22522 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1044022 1 Nonlinear solution status: time= 0.465862 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.715236e+09 4.922933e+02 0.000000e+00 energy 1.141402e+03 2.147707e+00 1.141402e+01 displacement 3.601600e+02 3.601600e+02 3.601600e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1051258 2 Nonlinear solution status: time= 0.465862 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.715236e+09 5.079478e+00 0.000000e+00 energy 1.141402e+03 5.637865e-02 1.141402e+01 displacement 3.601600e+02 3.502764e+00 3.498896e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1050052 3 Nonlinear solution status: time= 0.465862 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.715236e+09 2.275734e-01 0.000000e+00 energy 1.141402e+03 1.453287e-03 1.141402e+01 displacement 3.601600e+02 4.606674e-01 3.492906e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1049476 4 Nonlinear solution status: time= 0.465862 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.715236e+09 1.510294e-03 0.000000e+00 energy 1.141402e+03 1.057733e-04 1.141402e+01 displacement 3.601600e+02 5.589348e-02 3.489498e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1049278 5 Nonlinear solution status: time= 0.465862 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.715236e+09 2.147208e-04 0.000000e+00 energy 1.141402e+03 3.983094e-05 1.141402e+01 displacement 3.601600e+02 8.861193e-03 3.488588e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1049278 6 Nonlinear solution status: time= 0.465862 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.715236e+09 1.422133e-04 0.000000e+00 energy 1.141402e+03 2.065706e-05 1.141402e+01 displacement 3.601600e+02 3.060852e-03 3.487982e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1049278 7 Nonlinear solution status: time= 0.465862 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 7 step from line search = 0.396169 convergence norms : INITIAL CURRENT REQUIRED residual 2.715236e+09 5.293531e-05 0.000000e+00 energy 1.141402e+03 2.715094e-05 1.141402e+01 displacement 3.601600e+02 1.597709e-04 3.487835e-04 convergence summary number of iterations : 7 number of reformations : 7 ------- converged at time : 0.465862 Data Record #1 =========================================================================== Step = 5 Time = 0.465862409 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 5 Time = 0.465862409 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 5 Time = 0.465862409 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(47%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0921172 ===== beginning time step 6 : 0.55798 ===== Setting parameter "value" to : -1.46749 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1049260 1 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 2.968118e+01 0.000000e+00 energy 1.190317e+03 3.542839e+00 1.190317e+01 displacement 3.679247e+02 3.679247e+02 3.679247e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1065316 2 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 6.760522e-01 0.000000e+00 energy 1.190317e+03 1.019044e-01 1.190317e+01 displacement 3.679247e+02 1.092838e+00 3.677819e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1062382 3 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 2.641102e-02 0.000000e+00 energy 1.190317e+03 3.823218e-03 1.190317e+01 displacement 3.679247e+02 2.408286e-01 3.664858e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1060618 4 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 1.043146e-03 0.000000e+00 energy 1.190317e+03 2.793945e-04 1.190317e+01 displacement 3.679247e+02 2.091566e-02 3.657119e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1060276 5 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 1.709331e-03 0.000000e+00 energy 1.190317e+03 6.681991e-04 1.190317e+01 displacement 3.679247e+02 1.466816e-02 3.655547e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1060186 6 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 1.223180e-03 0.000000e+00 energy 1.190317e+03 1.438893e-03 1.190317e+01 displacement 3.679247e+02 1.043767e-02 3.655004e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1060186 7 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 1.013281e-03 0.000000e+00 energy 1.190317e+03 2.162363e-03 1.190317e+01 displacement 3.679247e+02 1.872584e-02 3.654029e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1060186 8 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 8 step from line search = 0.560156 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 9.930521e-04 0.000000e+00 energy 1.190317e+03 1.199283e-03 1.190317e+01 displacement 3.679247e+02 1.408259e-02 3.655707e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1060186 9 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 9 step from line search = 0.614035 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 6.231673e-04 0.000000e+00 energy 1.190317e+03 7.181381e-04 1.190317e+01 displacement 3.679247e+02 6.170787e-03 3.654645e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1060186 10 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 10 step from line search = 0.312909 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 2.624480e-04 0.000000e+00 energy 1.190317e+03 6.952572e-05 1.190317e+01 displacement 3.679247e+02 2.566419e-03 3.655387e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1060186 11 Nonlinear solution status: time= 0.55798 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 11 step from line search = 0.584321 convergence norms : INITIAL CURRENT REQUIRED residual 2.834417e+09 2.070331e-04 0.000000e+00 energy 1.190317e+03 8.197170e-05 1.190317e+01 displacement 3.679247e+02 1.379103e-04 3.655312e-04 convergence summary number of iterations : 11 number of reformations : 11 ------- converged at time : 0.55798 Data Record #1 =========================================================================== Step = 6 Time = 0.55797961 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 6 Time = 0.55797961 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 6 Time = 0.55797961 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(56%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: decreasing time step, dt = 0.0878768 ===== beginning time step 7 : 0.645856 ===== Setting parameter "value" to : -1.6986 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1060186 1 Nonlinear solution status: time= 0.645856 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.581315e+09 3.263461e+02 0.000000e+00 energy 1.083273e+03 6.323255e+00 1.083273e+01 displacement 3.239364e+02 3.239364e+02 3.239364e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1081138 2 Nonlinear solution status: time= 0.645856 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.581315e+09 1.961064e-01 0.000000e+00 energy 1.083273e+03 1.675990e-01 1.083273e+01 displacement 3.239364e+02 1.474620e+00 3.242915e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1077466 3 Nonlinear solution status: time= 0.645856 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.581315e+09 4.960258e-03 0.000000e+00 energy 1.083273e+03 3.782633e-03 1.083273e+01 displacement 3.239364e+02 1.006595e-01 3.240816e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1075972 4 Nonlinear solution status: time= 0.645856 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.581315e+09 7.269490e-04 0.000000e+00 energy 1.083273e+03 2.715498e-04 1.083273e+01 displacement 3.239364e+02 1.297998e-02 3.239132e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1075522 5 Nonlinear solution status: time= 0.645856 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.581315e+09 3.864528e-04 0.000000e+00 energy 1.083273e+03 1.347726e-04 1.083273e+01 displacement 3.239364e+02 4.241568e-03 3.237657e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1075522 6 Nonlinear solution status: time= 0.645856 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.581315e+09 4.665119e-04 0.000000e+00 energy 1.083273e+03 4.944785e-06 1.083273e+01 displacement 3.239364e+02 1.577652e-03 3.237288e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1075522 7 Nonlinear solution status: time= 0.645856 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 7 step from line search = 0.575305 convergence norms : INITIAL CURRENT REQUIRED residual 2.581315e+09 3.128640e-04 0.000000e+00 energy 1.083273e+03 2.583856e-04 1.083273e+01 displacement 3.239364e+02 6.939332e-04 3.237096e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1075522 8 Nonlinear solution status: time= 0.645856 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 8 step from line search = 0.586822 convergence norms : INITIAL CURRENT REQUIRED residual 2.581315e+09 1.071898e-04 0.000000e+00 energy 1.083273e+03 1.124053e-04 1.083273e+01 displacement 3.239364e+02 9.640966e-04 3.237562e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1075522 9 Nonlinear solution status: time= 0.645856 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 9 step from line search = 0.616744 convergence norms : INITIAL CURRENT REQUIRED residual 2.581315e+09 4.741442e-04 0.000000e+00 energy 1.083273e+03 1.809374e-05 1.083273e+01 displacement 3.239364e+02 1.883634e-04 3.237346e-04 convergence summary number of iterations : 9 number of reformations : 9 ------- converged at time : 0.645856 Data Record #1 =========================================================================== Step = 7 Time = 0.645856452 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 7 Time = 0.645856452 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 7 Time = 0.645856452 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(65%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0885326 ===== beginning time step 8 : 0.734389 ===== Setting parameter "value" to : -1.93144 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1075522 1 Nonlinear solution status: time= 0.734389 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.620284e+09 2.457541e+02 0.000000e+00 energy 1.099717e+03 3.572086e+00 1.099717e+01 displacement 3.291385e+02 3.291385e+02 3.291385e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1092730 2 Nonlinear solution status: time= 0.734389 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.620284e+09 1.134500e-01 0.000000e+00 energy 1.099717e+03 8.702207e-02 1.099717e+01 displacement 3.291385e+02 8.226494e-01 3.334294e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1089958 3 Nonlinear solution status: time= 0.734389 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.620284e+09 4.452325e-03 0.000000e+00 energy 1.099717e+03 3.089631e-03 1.099717e+01 displacement 3.291385e+02 7.618654e-02 3.333717e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1088248 4 Nonlinear solution status: time= 0.734389 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.620284e+09 8.724410e-04 0.000000e+00 energy 1.099717e+03 3.937923e-04 1.099717e+01 displacement 3.291385e+02 4.969647e-02 3.334992e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1087996 5 Nonlinear solution status: time= 0.734389 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.620284e+09 6.444637e-05 0.000000e+00 energy 1.099717e+03 3.501894e-05 1.099717e+01 displacement 3.291385e+02 5.727277e-03 3.336528e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1087996 6 Nonlinear solution status: time= 0.734389 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.620284e+09 9.412270e-07 0.000000e+00 energy 1.099717e+03 1.066745e-07 1.099717e+01 displacement 3.291385e+02 1.838810e-04 3.336768e-04 convergence summary number of iterations : 6 number of reformations : 6 ------- converged at time : 0.734389 Data Record #1 =========================================================================== Step = 8 Time = 0.734389067 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 8 Time = 0.734389067 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 8 Time = 0.734389067 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(73%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0908261 ===== beginning time step 9 : 0.825215 ===== Setting parameter "value" to : -2.17032 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1087942 1 Nonlinear solution status: time= 0.825215 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.756449e+09 3.478556e+02 0.000000e+00 energy 1.158234e+03 5.072717e+00 1.158234e+01 displacement 3.486541e+02 3.486541e+02 3.486541e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1104466 2 Nonlinear solution status: time= 0.825215 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.756449e+09 1.223311e-01 0.000000e+00 energy 1.158234e+03 9.056566e-02 1.158234e+01 displacement 3.486541e+02 1.034714e+00 3.508712e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1101298 3 Nonlinear solution status: time= 0.825215 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.756449e+09 9.111956e-03 0.000000e+00 energy 1.158234e+03 5.875792e-03 1.158234e+01 displacement 3.486541e+02 1.175004e-01 3.510978e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1100056 4 Nonlinear solution status: time= 0.825215 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.756449e+09 2.799795e-03 0.000000e+00 energy 1.158234e+03 1.516714e-03 1.158234e+01 displacement 3.486541e+02 1.155487e-01 3.518266e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1099570 5 Nonlinear solution status: time= 0.825215 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.756449e+09 2.847212e-04 0.000000e+00 energy 1.158234e+03 1.219587e-04 1.158234e+01 displacement 3.486541e+02 1.793866e-02 3.521157e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1099516 6 Nonlinear solution status: time= 0.825215 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.756449e+09 9.298416e-05 0.000000e+00 energy 1.158234e+03 3.049165e-05 1.158234e+01 displacement 3.486541e+02 8.892285e-04 3.520879e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1099516 7 Nonlinear solution status: time= 0.825215 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.756449e+09 1.493754e-04 0.000000e+00 energy 1.158234e+03 4.595084e-05 1.158234e+01 displacement 3.486541e+02 5.512018e-04 3.520650e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1099516 8 Nonlinear solution status: time= 0.825215 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 8 step from line search = 0.572114 convergence norms : INITIAL CURRENT REQUIRED residual 2.756449e+09 2.730681e-05 0.000000e+00 energy 1.158234e+03 3.309030e-05 1.158234e+01 displacement 3.486541e+02 1.533225e-04 3.520533e-04 convergence summary number of iterations : 8 number of reformations : 8 ------- converged at time : 0.825215 Data Record #1 =========================================================================== Step = 9 Time = 0.825215159 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 9 Time = 0.825215159 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 9 Time = 0.825215159 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(83%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0919089 ===== beginning time step 10 : 0.917124 ===== Setting parameter "value" to : -2.41204 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1099516 1 Nonlinear solution status: time= 0.917124 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.819296e+09 6.498006e+02 0.000000e+00 energy 1.187113e+03 6.739631e+00 1.187113e+01 displacement 3.600149e+02 3.600149e+02 3.600149e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1115680 2 Nonlinear solution status: time= 0.917124 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.819296e+09 1.405665e-01 0.000000e+00 energy 1.187113e+03 9.923735e-02 1.187113e+01 displacement 3.600149e+02 1.205477e+00 3.632706e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1112782 3 Nonlinear solution status: time= 0.917124 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.819296e+09 1.900910e-02 0.000000e+00 energy 1.187113e+03 1.116904e-02 1.187113e+01 displacement 3.600149e+02 1.377512e-01 3.640137e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1111558 4 Nonlinear solution status: time= 0.917124 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.819296e+09 6.845885e-03 0.000000e+00 energy 1.187113e+03 3.340757e-03 1.187113e+01 displacement 3.600149e+02 2.815121e-01 3.658936e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1110946 5 Nonlinear solution status: time= 0.917124 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.819296e+09 1.041072e-03 0.000000e+00 energy 1.187113e+03 5.987775e-04 1.187113e+01 displacement 3.600149e+02 8.568404e-02 3.665596e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1110748 6 Nonlinear solution status: time= 0.917124 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.819296e+09 2.847050e-04 0.000000e+00 energy 1.187113e+03 9.927330e-05 1.187113e+01 displacement 3.600149e+02 1.320847e-03 3.666214e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1110676 7 Nonlinear solution status: time= 0.917124 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.819296e+09 1.838457e-04 0.000000e+00 energy 1.187113e+03 8.679742e-05 1.187113e+01 displacement 3.600149e+02 6.663472e-04 3.666584e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1110676 8 Nonlinear solution status: time= 0.917124 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.819296e+09 1.660449e-04 0.000000e+00 energy 1.187113e+03 4.884988e-05 1.187113e+01 displacement 3.600149e+02 5.988787e-04 3.666923e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1110694 9 Nonlinear solution status: time= 0.917124 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.819296e+09 1.767182e-04 0.000000e+00 energy 1.187113e+03 2.016448e-05 1.187113e+01 displacement 3.600149e+02 2.778789e-04 3.667107e-04 convergence summary number of iterations : 9 number of reformations : 9 ------- converged at time : 0.917124 Data Record #1 =========================================================================== Step = 10 Time = 0.917124084 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 10 Time = 0.917124084 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 10 Time = 0.917124084 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(92%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0923466 MUST POINT CONTROLLER: adjusting time step. dt = 0.0828759 ===== beginning time step 11 : 1 ===== Setting parameter "value" to : -2.63 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1110658 1 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.287572e+09 8.154517e+02 0.000000e+00 energy 9.662930e+02 9.384676e+00 9.662930e+00 displacement 2.993649e+02 2.993649e+02 2.993649e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1123780 2 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.287572e+09 1.378974e-01 0.000000e+00 energy 9.662930e+02 1.153707e-01 9.662930e+00 displacement 2.993649e+02 1.734767e+00 3.022300e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1121584 3 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.287572e+09 3.174064e-02 0.000000e+00 energy 9.662930e+02 1.406672e-02 9.662930e+00 displacement 2.993649e+02 8.869875e-02 3.030244e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1121044 4 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.287572e+09 1.273912e-02 0.000000e+00 energy 9.662930e+02 8.115233e-03 9.662930e+00 displacement 2.993649e+02 5.073313e-01 3.056616e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1120792 5 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.287572e+09 3.507512e-03 0.000000e+00 energy 9.662930e+02 1.639356e-03 9.662930e+00 displacement 2.993649e+02 1.577483e-01 3.066667e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1120738 6 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.287572e+09 1.555671e-04 0.000000e+00 energy 9.662930e+02 1.123703e-04 9.662930e+00 displacement 2.993649e+02 1.640993e-02 3.068957e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1120720 7 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.287572e+09 1.218360e-04 0.000000e+00 energy 9.662930e+02 1.574520e-05 9.662930e+00 displacement 2.993649e+02 3.408222e-04 3.069166e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1120720 8 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.287572e+09 3.503460e-05 0.000000e+00 energy 9.662930e+02 2.005269e-05 9.662930e+00 displacement 2.993649e+02 2.147598e-04 3.069242e-04 convergence summary number of iterations : 8 number of reformations : 8 ------- converged at time : 1 Data Record #1 =========================================================================== Step = 11 Time = 1 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 11 Time = 1 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 11 Time = 1 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(100%) tempModel.feb - FEBio 3.3.3 N O N L I N E A R I T E R A T I O N I N F O R M A T I O N Number of time steps completed .................... : 11 Total number of equilibrium iterations ............ : 90 Average number of equilibrium iterations .......... : 8.18182 Total number of right hand evaluations ............ : 120 Total number of stiffness reformations ............ : 90 L I N E A R S O L V E R S T A T S Total calls to linear solver ........ : 90 Avg iterations per solve ............ : 1 Time in linear solver: 0:00:55 ]0;(100%) tempModel.feb - FEBio 3.3.3 Elapsed time : 0:01:43 N O R M A L T E R M I N A T I O N * Log file found. 29-Apr-2021 14:19:35 # Parsing log file... 29-Apr-2021 14:19:35 number of iterations : 2 29-Apr-2021 14:19:35 number of reformations : 2 29-Apr-2021 14:19:35 ------- converged at time : 0.1 29-Apr-2021 14:19:35 number of iterations : 13 29-Apr-2021 14:19:35 number of reformations : 13 29-Apr-2021 14:19:35 ------- converged at time : 0.2 29-Apr-2021 14:19:35 number of iterations : 10 29-Apr-2021 14:19:35 number of reformations : 10 29-Apr-2021 14:19:35 ------- converged at time : 0.287829 29-Apr-2021 14:19:35 number of iterations : 7 29-Apr-2021 14:19:35 number of reformations : 7 29-Apr-2021 14:19:35 ------- converged at time : 0.375657 29-Apr-2021 14:19:35 number of iterations : 7 29-Apr-2021 14:19:35 number of reformations : 7 29-Apr-2021 14:19:35 ------- converged at time : 0.465862 29-Apr-2021 14:19:35 number of iterations : 11 29-Apr-2021 14:19:35 number of reformations : 11 29-Apr-2021 14:19:35 ------- converged at time : 0.55798 29-Apr-2021 14:19:35 number of iterations : 9 29-Apr-2021 14:19:35 number of reformations : 9 29-Apr-2021 14:19:35 ------- converged at time : 0.645856 29-Apr-2021 14:19:35 number of iterations : 6 29-Apr-2021 14:19:35 number of reformations : 6 29-Apr-2021 14:19:35 ------- converged at time : 0.734389 29-Apr-2021 14:19:35 number of iterations : 8 29-Apr-2021 14:19:35 number of reformations : 8 29-Apr-2021 14:19:35 ------- converged at time : 0.825215 29-Apr-2021 14:19:35 number of iterations : 9 29-Apr-2021 14:19:35 number of reformations : 9 29-Apr-2021 14:19:35 ------- converged at time : 0.917124 29-Apr-2021 14:19:35 number of iterations : 8 29-Apr-2021 14:19:35 number of reformations : 8 29-Apr-2021 14:19:35 ------- converged at time : 1 29-Apr-2021 14:19:35 Elapsed time : 0:01:43 29-Apr-2021 14:19:35 N O R M A L T E R M I N A T I O N # Done 29-Apr-2021 14:19:35 %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
if optimizeForceOption==0
Export input file
Exporting the febio_spec structure to an FEBio input file is done using the febioStruct2xml function.
febioStruct2xml(febio_spec,febioFebFileName); %Exporting to file and domNode
Run febio
[runFlag]=runMonitorFEBio(febioAnalysis);%START FEBio NOW!!!!!!!! if runFlag~=1 error('FEBio error'); end
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% --------> RUNNING/MONITORING FEBIO JOB <-------- 29-Apr-2021 14:19:37 FEBio path: /home/kevin/FEBioStudio/bin/febio3 # Attempt removal of existing log files 29-Apr-2021 14:19:37 * Removal succesful 29-Apr-2021 14:19:37 # Attempt removal of existing .xplt files 29-Apr-2021 14:19:37 * Removal succesful 29-Apr-2021 14:19:37 # Starting FEBio... 29-Apr-2021 14:19:37 Max. total analysis time is: Inf s =========================================================================== ________ _________ _______ __ _________ | |\ | |\ | \\ | |\ / \\ | ____|| | ____|| | __ || |__|| | ___ || | |\___\| | |\___\| | |\_| || \_\| | // \ || | ||__ | ||__ | ||_| || | |\ | || | || | |\ | |\ | \\ | || | || | || | ___|| | ___|| | ___ || | || | || | || | |\__\| | |\__\| | |\__| || | || | || | || | || | ||___ | ||__| || | || | \\__/ || | || | |\ | || | || | || |___|| |________|| |_________// |__|| \_________// F I N I T E E L E M E N T S F O R B I O M E C H A N I C S version 3.3.3 FEBio is a registered trademark. copyright (c) 2006-2020 - All rights reserved =========================================================================== Default linear solver: pardiso Success loading plugin libFEBioChem.so (version 1.0.0) Success loading plugin libFEBioHeat.so (version 1.0.0) Reading file /mnt/data/MATLAB/GIBBON/data/temp/tempModel.feb ...SUCCESS! Setting parameter "value" to : -0 ]0;(0%) tempModel.feb - FEBio 3.3.3 ===== beginning time step 1 : 0.1 ===== Setting parameter "value" to : -0.263 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1038640 1 Nonlinear solution status: time= 0.1 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329175e+09 2.900981e-04 0.000000e+00 energy 1.403759e+03 4.194621e-06 1.403759e+01 displacement 4.096680e+02 4.096680e+02 4.096680e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1038640 2 Nonlinear solution status: time= 0.1 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329175e+09 1.662820e-18 0.000000e+00 energy 1.403759e+03 1.462298e-18 1.403759e+01 displacement 4.096680e+02 7.005336e-12 4.096680e-04 convergence summary number of iterations : 2 number of reformations : 2 ------- converged at time : 0.1 Data Record #1 =========================================================================== Step = 1 Time = 0.1 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 1 Time = 0.1 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 1 Time = 0.1 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(10%) tempModel.feb - FEBio 3.3.3 ===== beginning time step 2 : 0.2 ===== Setting parameter "value" to : -0.526 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1038640 1 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329189e+09 1.275148e-01 0.000000e+00 energy 1.403749e+03 1.467989e-01 1.403749e+01 displacement 4.095769e+02 4.095769e+02 4.095769e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039972 2 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329189e+09 1.240922e+01 0.000000e+00 energy 1.403749e+03 4.084167e-03 1.403749e+01 displacement 4.095769e+02 4.291557e+00 4.304696e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039738 3 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329189e+09 8.529332e-01 0.000000e+00 energy 1.403749e+03 1.178730e-04 1.403749e+01 displacement 4.095769e+02 5.613869e-01 4.381648e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039648 4 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329189e+09 1.119241e-01 0.000000e+00 energy 1.403749e+03 2.636117e-05 1.403749e+01 displacement 4.095769e+02 2.287508e-01 4.404966e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 5 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.329189e+09 9.374032e-03 0.000000e+00 energy 1.403749e+03 1.309866e-04 1.403749e+01 displacement 4.095769e+02 8.010861e-02 4.415033e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 6 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 6 step from line search = 0.511521 convergence norms : INITIAL CURRENT REQUIRED residual 3.329189e+09 3.819812e-02 0.000000e+00 energy 1.403749e+03 3.416632e-06 1.403749e+01 displacement 4.095769e+02 1.445449e-01 4.406137e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 7 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 7 step from line search = 0.598165 convergence norms : INITIAL CURRENT REQUIRED residual 3.329189e+09 7.877958e-03 0.000000e+00 energy 1.403749e+03 2.152460e-06 1.403749e+01 displacement 4.095769e+02 1.782951e-02 4.407867e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 8 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 8 step from line search = 0.381479 convergence norms : INITIAL CURRENT REQUIRED residual 3.329189e+09 3.083101e-03 0.000000e+00 energy 1.403749e+03 5.500362e-07 1.403749e+01 displacement 4.095769e+02 5.784040e-04 4.407468e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 9 Nonlinear solution status: time= 0.2 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 9 step from line search = 0.269970 convergence norms : INITIAL CURRENT REQUIRED residual 3.329189e+09 1.643367e-03 0.000000e+00 energy 1.403749e+03 1.316238e-07 1.403749e+01 displacement 4.095769e+02 3.695761e-06 4.407419e-04 convergence summary number of iterations : 9 number of reformations : 9 ------- converged at time : 0.2 Data Record #1 =========================================================================== Step = 2 Time = 0.2 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 2 Time = 0.2 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 2 Time = 0.2 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(20%) tempModel.feb - FEBio 3.3.3 ===== beginning time step 3 : 0.3 ===== Setting parameter "value" to : -0.789 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1039612 1 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 3.346288e+03 0.000000e+00 energy 1.403715e+03 1.475521e+00 1.403715e+01 displacement 4.798891e+02 4.798891e+02 4.798891e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1042276 2 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 3.397359e+02 0.000000e+00 energy 1.403715e+03 4.135778e-02 1.403715e+01 displacement 4.798891e+02 1.232135e+01 4.787476e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041934 3 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 7.660720e+00 0.000000e+00 energy 1.403715e+03 2.013645e-03 1.403715e+01 displacement 4.798891e+02 2.082799e+00 4.788535e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041700 4 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 3.250421e-01 0.000000e+00 energy 1.403715e+03 2.878996e-04 1.403715e+01 displacement 4.798891e+02 3.878759e-01 4.818312e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041646 5 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 6.869417e-04 0.000000e+00 energy 1.403715e+03 9.000830e-05 1.403715e+01 displacement 4.798891e+02 1.114549e-02 4.821616e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041700 6 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 2.308400e-03 0.000000e+00 energy 1.403715e+03 4.149653e-05 1.403715e+01 displacement 4.798891e+02 3.801363e-02 4.802877e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041700 7 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 3.553549e-04 0.000000e+00 energy 1.403715e+03 1.335254e-04 1.403715e+01 displacement 4.798891e+02 5.596072e-03 4.794316e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041700 8 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 7.170556e-02 0.000000e+00 energy 1.403715e+03 1.225278e-04 1.403715e+01 displacement 4.798891e+02 2.335648e-01 4.743062e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041700 9 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 3.190257e-06 0.000000e+00 energy 1.403715e+03 1.476231e-06 1.403715e+01 displacement 4.798891e+02 2.265545e-03 4.738572e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041700 10 Nonlinear solution status: time= 0.3 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.331471e+09 3.919395e-08 0.000000e+00 energy 1.403715e+03 7.862584e-10 1.403715e+01 displacement 4.798891e+02 1.508582e-04 4.740390e-04 convergence summary number of iterations : 10 number of reformations : 10 ------- converged at time : 0.3 Data Record #1 =========================================================================== Step = 3 Time = 0.3 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 3 Time = 0.3 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 3 Time = 0.3 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(30%) tempModel.feb - FEBio 3.3.3 ===== beginning time step 4 : 0.4 ===== Setting parameter "value" to : -1.052 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1041664 1 Nonlinear solution status: time= 0.4 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.334222e+09 3.445679e+02 0.000000e+00 energy 1.402998e+03 1.154566e+00 1.402998e+01 displacement 4.395677e+02 4.395677e+02 4.395677e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1047028 2 Nonlinear solution status: time= 0.4 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.334222e+09 1.378957e+01 0.000000e+00 energy 1.402998e+03 3.120290e-02 1.402998e+01 displacement 4.395677e+02 3.024373e+00 4.386388e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1045696 3 Nonlinear solution status: time= 0.4 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.334222e+09 1.036827e-03 0.000000e+00 energy 1.402998e+03 5.195726e-04 1.402998e+01 displacement 4.395677e+02 1.017677e-01 4.411435e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1045318 4 Nonlinear solution status: time= 0.4 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.334222e+09 2.647823e-04 0.000000e+00 energy 1.402998e+03 7.356316e-05 1.402998e+01 displacement 4.395677e+02 1.087652e-02 4.405898e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1045336 5 Nonlinear solution status: time= 0.4 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.334222e+09 1.929762e-04 0.000000e+00 energy 1.402998e+03 6.853039e-05 1.402998e+01 displacement 4.395677e+02 9.251219e-03 4.399590e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1045336 6 Nonlinear solution status: time= 0.4 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.334222e+09 4.597469e-04 0.000000e+00 energy 1.402998e+03 1.080441e-04 1.402998e+01 displacement 4.395677e+02 8.090195e-03 4.393511e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1045336 7 Nonlinear solution status: time= 0.4 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 7 step from line search = 0.571329 convergence norms : INITIAL CURRENT REQUIRED residual 3.334222e+09 2.254112e-04 0.000000e+00 energy 1.402998e+03 1.912045e-04 1.402998e+01 displacement 4.395677e+02 3.692990e-03 4.389522e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1045156 8 Nonlinear solution status: time= 0.4 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 8 step from line search = 0.214896 convergence norms : INITIAL CURRENT REQUIRED residual 3.334222e+09 1.728494e-04 0.000000e+00 energy 1.402998e+03 2.087958e-05 1.402998e+01 displacement 4.395677e+02 9.426923e-05 4.388826e-04 convergence summary number of iterations : 8 number of reformations : 8 ------- converged at time : 0.4 Data Record #1 =========================================================================== Step = 4 Time = 0.4 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 4 Time = 0.4 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 4 Time = 0.4 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(40%) tempModel.feb - FEBio 3.3.3 ===== beginning time step 5 : 0.5 ===== Setting parameter "value" to : -1.315 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1045102 1 Nonlinear solution status: time= 0.5 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.337659e+09 1.882277e+02 0.000000e+00 energy 1.402727e+03 2.735469e+00 1.402727e+01 displacement 4.263297e+02 4.263297e+02 4.263297e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1054012 2 Nonlinear solution status: time= 0.5 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.337659e+09 3.729934e+00 0.000000e+00 energy 1.402727e+03 6.147183e-02 1.402727e+01 displacement 4.263297e+02 1.770548e+00 4.298733e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1052284 3 Nonlinear solution status: time= 0.5 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.337659e+09 2.404485e-02 0.000000e+00 energy 1.402727e+03 1.201254e-03 1.402727e+01 displacement 4.263297e+02 1.602922e-01 4.305007e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1051384 4 Nonlinear solution status: time= 0.5 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.337659e+09 7.136282e-05 0.000000e+00 energy 1.402727e+03 2.194178e-05 1.402727e+01 displacement 4.263297e+02 5.017791e-03 4.304658e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1051312 5 Nonlinear solution status: time= 0.5 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.337659e+09 4.904185e-05 0.000000e+00 energy 1.402727e+03 1.042391e-05 1.402727e+01 displacement 4.263297e+02 1.146732e-04 4.304371e-04 convergence summary number of iterations : 5 number of reformations : 5 ------- converged at time : 0.5 Data Record #1 =========================================================================== Step = 5 Time = 0.5 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 5 Time = 0.5 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 5 Time = 0.5 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(50%) tempModel.feb - FEBio 3.3.3 ===== beginning time step 6 : 0.6 ===== Setting parameter "value" to : -1.578 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1051258 1 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 8.727261e+01 0.000000e+00 energy 1.402914e+03 1.322775e+01 1.402914e+01 displacement 4.419246e+02 4.419246e+02 4.419246e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1074586 2 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 6.807537e+00 0.000000e+00 energy 1.402914e+03 3.557875e-01 1.402914e+01 displacement 4.419246e+02 3.815141e+00 4.283075e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1070770 3 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 1.832997e-01 0.000000e+00 energy 1.402914e+03 9.721254e-03 1.402914e+01 displacement 4.419246e+02 5.160787e-01 4.244219e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1068412 4 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 4.746387e-03 0.000000e+00 energy 1.402914e+03 1.394255e-03 1.402914e+01 displacement 4.419246e+02 6.595010e-02 4.230364e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067800 5 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 5.104301e-03 0.000000e+00 energy 1.402914e+03 2.593762e-03 1.402914e+01 displacement 4.419246e+02 3.874899e-02 4.226099e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067530 6 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 4.694952e-03 0.000000e+00 energy 1.402914e+03 5.255025e-03 1.402914e+01 displacement 4.419246e+02 3.497028e-02 4.225400e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067494 7 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 7 step from line search = 0.625184 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 3.121944e-03 0.000000e+00 energy 1.402914e+03 1.507547e-03 1.402914e+01 displacement 4.419246e+02 1.630853e-02 4.224116e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067494 8 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 8 step from line search = 0.577706 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 1.810932e-03 0.000000e+00 energy 1.402914e+03 7.245024e-04 1.402914e+01 displacement 4.419246e+02 8.843188e-03 4.220422e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067530 9 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 9 step from line search = 0.572819 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 2.201617e-03 0.000000e+00 energy 1.402914e+03 1.245085e-03 1.402914e+01 displacement 4.419246e+02 4.299580e-03 4.219290e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067494 10 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 10 step from line search = 0.353184 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 1.945569e-03 0.000000e+00 energy 1.402914e+03 6.987005e-04 1.402914e+01 displacement 4.419246e+02 2.736858e-03 4.219866e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067512 11 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 11 step from line search = 0.238261 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 2.057807e-03 0.000000e+00 energy 1.402914e+03 5.883313e-04 1.402914e+01 displacement 4.419246e+02 1.044862e-03 4.219336e-04 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067512 12 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 24 stiffness matrix reformations = 12 step from line search = 0.237813 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 1.993768e-03 0.000000e+00 energy 1.402914e+03 5.201229e-04 1.402914e+01 displacement 4.419246e+02 7.660275e-04 4.219628e-04 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067512 13 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 28 stiffness matrix reformations = 13 step from line search = 0.238371 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 2.316659e-03 0.000000e+00 energy 1.402914e+03 5.082337e-04 1.402914e+01 displacement 4.419246e+02 8.686063e-04 4.218909e-04 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067512 14 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 31 stiffness matrix reformations = 14 step from line search = 0.365175 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 2.247789e-03 0.000000e+00 energy 1.402914e+03 1.090059e-03 1.402914e+01 displacement 4.419246e+02 4.130897e-03 4.218230e-04 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067476 15 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 35 stiffness matrix reformations = 15 step from line search = 0.222089 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 1.412665e-03 0.000000e+00 energy 1.402914e+03 6.711109e-04 1.402914e+01 displacement 4.419246e+02 2.035171e-03 4.217675e-04 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067512 16 Nonlinear solution status: time= 0.6 stiffness updates = 0 right hand side evaluations = 39 stiffness matrix reformations = 16 step from line search = 0.237556 convergence norms : INITIAL CURRENT REQUIRED residual 3.340966e+09 1.014127e-03 0.000000e+00 energy 1.402914e+03 1.841581e-04 1.402914e+01 displacement 4.419246e+02 2.603332e-04 4.217421e-04 convergence summary number of iterations : 16 number of reformations : 16 ------- converged at time : 0.6 Data Record #1 =========================================================================== Step = 6 Time = 0.6 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 6 Time = 0.6 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 6 Time = 0.6 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(60%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: decreasing time step, dt = 0.0792664 ===== beginning time step 7 : 0.679266 ===== Setting parameter "value" to : -1.78647 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1067476 1 Nonlinear solution status: time= 0.679266 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.100397e+09 1.740198e+02 0.000000e+00 energy 8.814299e+02 4.168827e+00 8.814299e+00 displacement 2.614370e+02 2.614370e+02 2.614370e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1084342 2 Nonlinear solution status: time= 0.679266 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.100397e+09 1.158701e-01 0.000000e+00 energy 8.814299e+02 1.074824e-01 8.814299e+00 displacement 2.614370e+02 1.086337e+00 2.648415e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1081966 3 Nonlinear solution status: time= 0.679266 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.100397e+09 3.559142e-03 0.000000e+00 energy 8.814299e+02 3.059496e-03 8.814299e+00 displacement 2.614370e+02 4.997909e-02 2.649268e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1080814 4 Nonlinear solution status: time= 0.679266 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.100397e+09 3.897679e-04 0.000000e+00 energy 8.814299e+02 2.460911e-04 8.814299e+00 displacement 2.614370e+02 1.441223e-02 2.650027e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1080472 5 Nonlinear solution status: time= 0.679266 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.100397e+09 1.102226e-04 0.000000e+00 energy 8.814299e+02 5.929780e-05 8.814299e+00 displacement 2.614370e+02 3.727332e-03 2.651523e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1080472 6 Nonlinear solution status: time= 0.679266 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.100397e+09 2.085448e-05 0.000000e+00 energy 8.814299e+02 9.172175e-07 8.814299e+00 displacement 2.614370e+02 1.285901e-04 2.651438e-04 convergence summary number of iterations : 6 number of reformations : 6 ------- converged at time : 0.679266 Data Record #1 =========================================================================== Step = 7 Time = 0.679266372 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 7 Time = 0.679266372 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 7 Time = 0.679266372 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(68%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0834131 ===== beginning time step 8 : 0.762679 ===== Setting parameter "value" to : -2.00585 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1080472 1 Nonlinear solution status: time= 0.762679 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.325646e+09 2.395800e+02 0.000000e+00 energy 9.764565e+02 3.360918e+00 9.764565e+00 displacement 2.950732e+02 2.950732e+02 2.950732e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1096114 2 Nonlinear solution status: time= 0.762679 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.325646e+09 1.018338e-01 0.000000e+00 energy 9.764565e+02 8.774398e-02 9.764565e+00 displacement 2.950732e+02 6.737087e-01 2.962420e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1092964 3 Nonlinear solution status: time= 0.762679 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.325646e+09 5.233435e-03 0.000000e+00 energy 9.764565e+02 3.711455e-03 9.764565e+00 displacement 2.950732e+02 1.152338e-01 2.960940e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1091902 4 Nonlinear solution status: time= 0.762679 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.325646e+09 8.283899e-04 0.000000e+00 energy 9.764565e+02 2.880976e-04 9.764565e+00 displacement 2.950732e+02 5.623142e-02 2.963246e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1091740 5 Nonlinear solution status: time= 0.762679 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.325646e+09 2.711109e-05 0.000000e+00 energy 9.764565e+02 2.098085e-05 9.764565e+00 displacement 2.950732e+02 9.190343e-04 2.963495e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1091686 6 Nonlinear solution status: time= 0.762679 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.325646e+09 4.831155e-06 0.000000e+00 energy 9.764565e+02 2.368511e-06 9.764565e+00 displacement 2.950732e+02 1.241987e-04 2.963377e-04 convergence summary number of iterations : 6 number of reformations : 6 ------- converged at time : 0.762679 Data Record #1 =========================================================================== Step = 8 Time = 0.76267947 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 8 Time = 0.76267947 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 8 Time = 0.76267947 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(76%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0867305 ===== beginning time step 9 : 0.84941 ===== Setting parameter "value" to : -2.23395 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1091686 1 Nonlinear solution status: time= 0.84941 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.512654e+09 2.882058e+02 0.000000e+00 energy 1.056409e+03 4.171120e+00 1.056409e+01 displacement 3.187722e+02 3.187722e+02 3.187722e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1107022 2 Nonlinear solution status: time= 0.84941 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.512654e+09 1.089915e-01 0.000000e+00 energy 1.056409e+03 6.895960e-02 1.056409e+01 displacement 3.187722e+02 8.632955e-01 3.204655e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1104088 3 Nonlinear solution status: time= 0.84941 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.512654e+09 9.680962e-03 0.000000e+00 energy 1.056409e+03 5.518206e-03 1.056409e+01 displacement 3.187722e+02 9.495711e-02 3.209979e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1103206 4 Nonlinear solution status: time= 0.84941 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.512654e+09 3.118168e-03 0.000000e+00 energy 1.056409e+03 1.704846e-03 1.056409e+01 displacement 3.187722e+02 1.062502e-01 3.219552e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1102972 5 Nonlinear solution status: time= 0.84941 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.512654e+09 4.257508e-04 0.000000e+00 energy 1.056409e+03 2.179617e-04 1.056409e+01 displacement 3.187722e+02 2.710201e-02 3.223267e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1102954 6 Nonlinear solution status: time= 0.84941 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.512654e+09 1.014466e-04 0.000000e+00 energy 1.056409e+03 4.074662e-05 1.056409e+01 displacement 3.187722e+02 1.094908e-03 3.223857e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1102954 7 Nonlinear solution status: time= 0.84941 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.512654e+09 1.184771e-04 0.000000e+00 energy 1.056409e+03 2.623699e-05 1.056409e+01 displacement 3.187722e+02 1.904258e-04 3.223952e-04 convergence summary number of iterations : 7 number of reformations : 7 ------- converged at time : 0.84941 Data Record #1 =========================================================================== Step = 9 Time = 0.849409948 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 9 Time = 0.849409948 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 9 Time = 0.849409948 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(85%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0893211 ===== beginning time step 10 : 0.938731 ===== Setting parameter "value" to : -2.46886 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1102936 1 Nonlinear solution status: time= 0.938731 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.661428e+09 6.220281e+02 0.000000e+00 energy 1.121496e+03 7.548883e+00 1.121496e+01 displacement 3.400394e+02 3.400394e+02 3.400394e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1118002 2 Nonlinear solution status: time= 0.938731 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.661428e+09 1.316441e-01 0.000000e+00 energy 1.121496e+03 7.613701e-02 1.121496e+01 displacement 3.400394e+02 1.335523e+00 3.445365e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1115320 3 Nonlinear solution status: time= 0.938731 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.661428e+09 1.998631e-02 0.000000e+00 energy 1.121496e+03 1.013917e-02 1.121496e+01 displacement 3.400394e+02 8.096392e-02 3.454111e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1114420 4 Nonlinear solution status: time= 0.938731 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.661428e+09 8.003493e-03 0.000000e+00 energy 1.121496e+03 4.723015e-03 1.121496e+01 displacement 3.400394e+02 4.046127e-01 3.475141e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1114132 5 Nonlinear solution status: time= 0.938731 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.661428e+09 9.814028e-04 0.000000e+00 energy 1.121496e+03 6.437801e-04 1.121496e+01 displacement 3.400394e+02 1.020255e-01 3.484476e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1113844 6 Nonlinear solution status: time= 0.938731 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.661428e+09 6.177386e-05 0.000000e+00 energy 1.121496e+03 5.088192e-05 1.121496e+01 displacement 3.400394e+02 2.636763e-03 3.485368e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1113790 7 Nonlinear solution status: time= 0.938731 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.661428e+09 2.277652e-05 0.000000e+00 energy 1.121496e+03 4.842278e-06 1.121496e+01 displacement 3.400394e+02 1.946114e-04 3.485582e-04 convergence summary number of iterations : 7 number of reformations : 7 ------- converged at time : 0.938731 Data Record #1 =========================================================================== Step = 10 Time = 0.938731016 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 10 Time = 0.938731016 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 10 Time = 0.938731016 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(94%) tempModel.feb - FEBio 3.3.3 AUTO STEPPER: increasing time step, dt = 0.0914059 MUST POINT CONTROLLER: adjusting time step. dt = 0.061269 ===== beginning time step 11 : 1 ===== Setting parameter "value" to : -2.63 Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1113790 1 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.249379e+09 2.782492e+02 0.000000e+00 energy 5.282840e+02 3.216718e+00 5.282840e+00 displacement 1.642686e+02 1.642686e+02 1.642686e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1122664 2 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.249379e+09 1.142180e-01 0.000000e+00 energy 5.282840e+02 7.576686e-02 5.282840e+00 displacement 1.642686e+02 5.932344e-01 1.658178e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1121278 3 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.249379e+09 1.820555e-02 0.000000e+00 energy 5.282840e+02 9.113121e-03 5.282840e+00 displacement 1.642686e+02 6.460930e-02 1.663880e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1120846 4 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.249379e+09 8.015611e-03 0.000000e+00 energy 5.282840e+02 4.590335e-03 5.282840e+00 displacement 1.642686e+02 2.205626e-01 1.676907e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1120738 5 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.249379e+09 1.535325e-03 0.000000e+00 energy 5.282840e+02 8.324686e-04 5.282840e+00 displacement 1.642686e+02 1.123486e-01 1.684925e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1120648 6 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.249379e+09 9.815996e-05 0.000000e+00 energy 5.282840e+02 8.480964e-05 5.282840e+00 displacement 1.642686e+02 5.908312e-03 1.686246e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1120648 7 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.249379e+09 1.027444e-05 0.000000e+00 energy 5.282840e+02 1.041854e-05 5.282840e+00 displacement 1.642686e+02 1.937356e-04 1.686435e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 25396 Nr of nonzeroes in stiffness matrix ....... : 1120666 8 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.249379e+09 6.291594e-08 0.000000e+00 energy 5.282840e+02 6.771926e-08 5.282840e+00 displacement 1.642686e+02 3.950924e-05 1.686488e-04 convergence summary number of iterations : 8 number of reformations : 8 ------- converged at time : 1 Data Record #1 =========================================================================== Step = 11 Time = 1 Data = ux;uy;uz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt Data Record #2 =========================================================================== Step = 11 Time = 1 Data = Fx;Fy;Fz File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_force_out.txt Data Record #3 =========================================================================== Step = 11 Time = 1 Data = sed File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_energy_out.txt ]0;(100%) tempModel.feb - FEBio 3.3.3 N O N L I N E A R I T E R A T I O N I N F O R M A T I O N Number of time steps completed .................... : 11 Total number of equilibrium iterations ............ : 84 Average number of equilibrium iterations .......... : 7.63636 Total number of right hand evaluations ............ : 125 Total number of stiffness reformations ............ : 84 L I N E A R S O L V E R S T A T S Total calls to linear solver ........ : 84 Avg iterations per solve ............ : 1 Time in linear solver: 0:00:35 ]0;(100%) tempModel.feb - FEBio 3.3.3 Elapsed time : 0:01:52 N O R M A L T E R M I N A T I O N * Log file found. 29-Apr-2021 14:21:30 # Parsing log file... 29-Apr-2021 14:21:30 number of iterations : 2 29-Apr-2021 14:21:31 number of reformations : 2 29-Apr-2021 14:21:31 ------- converged at time : 0.1 29-Apr-2021 14:21:31 number of iterations : 9 29-Apr-2021 14:21:31 number of reformations : 9 29-Apr-2021 14:21:31 ------- converged at time : 0.2 29-Apr-2021 14:21:31 number of iterations : 10 29-Apr-2021 14:21:31 number of reformations : 10 29-Apr-2021 14:21:31 ------- converged at time : 0.3 29-Apr-2021 14:21:31 number of iterations : 8 29-Apr-2021 14:21:31 number of reformations : 8 29-Apr-2021 14:21:31 ------- converged at time : 0.4 29-Apr-2021 14:21:31 number of iterations : 5 29-Apr-2021 14:21:31 number of reformations : 5 29-Apr-2021 14:21:31 ------- converged at time : 0.5 29-Apr-2021 14:21:31 number of iterations : 16 29-Apr-2021 14:21:31 number of reformations : 16 29-Apr-2021 14:21:31 ------- converged at time : 0.6 29-Apr-2021 14:21:31 number of iterations : 6 29-Apr-2021 14:21:31 number of reformations : 6 29-Apr-2021 14:21:31 ------- converged at time : 0.679266 29-Apr-2021 14:21:31 number of iterations : 6 29-Apr-2021 14:21:31 number of reformations : 6 29-Apr-2021 14:21:31 ------- converged at time : 0.762679 29-Apr-2021 14:21:31 number of iterations : 7 29-Apr-2021 14:21:31 number of reformations : 7 29-Apr-2021 14:21:31 ------- converged at time : 0.84941 29-Apr-2021 14:21:31 number of iterations : 7 29-Apr-2021 14:21:31 number of reformations : 7 29-Apr-2021 14:21:31 ------- converged at time : 0.938731 29-Apr-2021 14:21:31 number of iterations : 8 29-Apr-2021 14:21:31 number of reformations : 8 29-Apr-2021 14:21:31 ------- converged at time : 1 29-Apr-2021 14:21:31 Elapsed time : 0:01:52 29-Apr-2021 14:21:31 N O R M A L T E R M I N A T I O N # Done 29-Apr-2021 14:21:31 %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
elseif optimizeForceOption==1 while 1
Set displacement magnitude in input file structure
febio_spec.Rigid.rigid_constraint{2}.value.VAL=displacementMagnitude;
Export input file
Exporting the febio_spec structure to an FEBio input file is done using the febioStruct2xml function.
febioStruct2xml(febio_spec,febioFebFileName); %Exporting to file and domNode
Run febio
[runFlag]=runMonitorFEBio(febioAnalysis);%START FEBio NOW!!!!!!!! if runFlag~=1 error('FEBio error'); end
Importing rigid body reaction forces from a log file
dataStructForce=importFEBio_logfile(fullfile(savePath,febioLogFileName_force),1,1); F_reaction=squeeze(dataStructForce.data(1,:,:))'; timeVec=dataStructForce.time; Fz_final=F_reaction(end,3); forceDifference=abs(Fz_final-forceBody);
Use inter/extra-polation to guess displacement
u=timeVec.*displacementMagnitude; f=F_reaction(:,3); displacementProposed=interp1(f,u,forceBody,'linear','extrap');
cFigure; hold on; hp(1)=plot(f,u,'r-','LineWidth',lineWidth); hp(2)=plot(forceBody,displacementProposed,'b.','MarkerSize',25); hl=legend(hp,{'displacement - force FEA','Proposed displacement'},'FontSize',fontSize); axis square; axis tight; grid on; box on; drawnow;
displacementDifference=displacementProposed-displacementMagnitude; if displacementDifference<-maxProposedDisplacementDifference displacementMagnitude=displacementMagnitude-maxProposedDisplacementDifference; else displacementMagnitude=displacementProposed; end
disp(['Force is: ',num2str(Fz_final),' N. Setting displacement to: ',num2str(displacementMagnitude)]); if forceDifference<forceDifferenceTolerance break end
end end
Import rigid body reaction forces
dataStructForce=importFEBio_logfile(fullfile(savePath,febioLogFileName_force),1,1); F_reaction=squeeze(dataStructForce.data(1,:,:))'; timeVec=dataStructForce.time;
Visualize force
cFigure; hold on; hp(1)=plot(timeVec,F_reaction(:,1),'r-','LineWidth',lineWidth); hp(2)=plot(timeVec,F_reaction(:,2),'g-','LineWidth',lineWidth); hp(3)=plot(timeVec,F_reaction(:,3),'b-','LineWidth',lineWidth); hl=legend(hp,{'$F_x$','$F_y$','$F_z$'},'Interpreter','Latex','FontSize',fontSize); axis square; axis tight; grid on; box on; drawnow;

Importing nodal displacements from a log file
dataStructDisp=importFEBio_logfile(fullfile(savePath,febioLogFileName_disp),1,1); %Access data N_disp_mat=dataStructDisp.data; %Displacement timeVec=dataStructDisp.time; %Time %Create deformed coordinate set V_DEF=N_disp_mat+repmat(V,[1 1 size(N_disp_mat,3)]);
Importing element strain energies from a log file
dataStructEnergy=importFEBio_logfile(fullfile(savePath,febioLogFileName_strainEnergy),1,1);
E_energy=dataStructEnergy.data(:,1,:);
[FE_foot,C_energy_foot]=element2patch(E_foot,E_energy(:,:,end));
% [FE_foot,C_energy_foot]=element2patch(E_foot,E_energy(1:size(E_foot,1),:,1));
indBoundaryFacesFoot=tesBoundary(FE_foot,V);

Plot animation
Plotting the simulated results using anim8 to visualize and animate deformations
% Create basic view and store graphics handle to initiate animation hf=cFigure; hold on; %Open figure gtitle([febioFebFileNamePart,': Press play to animate']); CV=faceToVertexMeasure(FE_foot(indBoundaryFacesFoot,:),V_DEF(:,:,end),C_energy_foot(indBoundaryFacesFoot)); hp1=gpatch(FE_foot(indBoundaryFacesFoot,:),V_DEF(:,:,end),CV,'k',1); %Add graphics object to animate hp1.FaceColor='Interp'; hp2=gpatch(F_E_sole{1},V_DEF(:,:,end),'kw','none',0.25); %Add graphics object to animate axisGeom(gca,fontSize); colormap(gjet(250)); colorbar; % caxis([0 max(C_energy_foot)/100]); caxis([0 maxLevelColorbar_SED]); axis(axisLim(V_DEF)); %Set axis limits statically view([-40 -40]); camlight headlight; % Set up animation features animStruct.Time=timeVec; %The time vector for qt=1:1:size(V_DEF,3) %Loop over time increments [FE_foot,C_energy_foot]=element2patch(E_foot,E_energy(:,:,qt)); CV=faceToVertexMeasure(FE_foot(indBoundaryFacesFoot,:),V_DEF(:,:,qt),C_energy_foot(indBoundaryFacesFoot)); %Set entries in animation structure animStruct.Handles{qt}=[hp1 hp1 hp2]; %Handles of objects to animate animStruct.Props{qt}={'Vertices','CData','Vertices'}; %Properties of objects to animate animStruct.Set{qt}={V_DEF(:,:,qt),CV,V_DEF(:,:,qt)}; %Property values for to set in order to animate end anim8(hf,animStruct); %Initiate animation feature drawnow;

GIBBON www.gibboncode.org
Kevin Mattheus Moerman, [email protected]
GIBBON footer text
License: https://github.com/gibbonCode/GIBBON/blob/master/LICENSE
GIBBON: The Geometry and Image-based Bioengineering add-On. A toolbox for image segmentation, image-based modeling, meshing, and finite element analysis.
Copyright (C) 2006-2021 Kevin Mattheus Moerman and the GIBBON contributors
This program is free software: you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version.
This program is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details.
You should have received a copy of the GNU General Public License along with this program. If not, see http://www.gnu.org/licenses/.